diff --git a/Base/Math/FourierTransform.cpp b/Base/Math/FourierTransform.cpp
index 3709ce55d32777e457eed9031e13ec5820eb6191..737b0c513a8b8ba9a3e8f02cb1ca0af0b2c3e894 100644
--- a/Base/Math/FourierTransform.cpp
+++ b/Base/Math/FourierTransform.cpp
@@ -33,10 +33,9 @@ template <typename T> std::vector<T> fftshift_1d(const std::vector<T>& src, bool
     return result;
 }
 
-template <typename T>
-std::vector<std::vector<T>> fftshift_2d(const std::vector<std::vector<T>>& src, bool inverse)
+template <typename T> Field2D<T> fftshift_2d(const Field2D<T>& src, bool inverse)
 {
-    std::vector<std::vector<T>> result = src;
+    Field2D<T> result = src;
 
     // Centering FT around zero frequency
     int row_shift = (result.size() + 1) / 2;
@@ -156,7 +155,7 @@ complex2d_t FourierTransform::ifftshift(const complex2d_t& src)
 /* ************************************************************************* */
 // Fourier Transform in 1D
 /* ************************************************************************* */
-complex1d_t FourierTransform::rfft(const double1d_t& src)
+std::vector<complex_t> FourierTransform::rfft(const std::vector<double>& src)
 {
     // we simply create 2d arrays with length of first dimension equal to 1, and call 2d FT
     double2d_t src2d{src};
@@ -166,7 +165,7 @@ complex1d_t FourierTransform::rfft(const double1d_t& src)
     return result2d[0];
 }
 
-double1d_t FourierTransform::irfft(const complex1d_t& src, int w_src)
+std::vector<double> FourierTransform::irfft(const std::vector<complex_t>& src, int w_src)
 {
     // we simply create 2d arrays with length of first dimension equal to 1, and call 2d FT
     complex2d_t source2d{src};
@@ -176,7 +175,7 @@ double1d_t FourierTransform::irfft(const complex1d_t& src, int w_src)
     return result2d[0];
 }
 
-double1d_t FourierTransform::ramplitude(const double1d_t& src)
+std::vector<double> FourierTransform::ramplitude(const std::vector<double>& src)
 {
     complex2d_t complex_result2d{rfft(src)};
 
@@ -189,20 +188,20 @@ double1d_t FourierTransform::ramplitude(const double1d_t& src)
 /* ************************************************************************* */
 // Fourier Transform 1D shift - center around zero frequency
 /* ************************************************************************* */
-double1d_t FourierTransform::fftshift(const double1d_t& src)
+std::vector<double> FourierTransform::fftshift(const std::vector<double>& src)
 {
     return ::fftshift_1d(src, false);
 }
-complex1d_t FourierTransform::fftshift(const complex1d_t& src)
+std::vector<complex_t> FourierTransform::fftshift(const std::vector<complex_t>& src)
 {
     return ::fftshift_1d(src, false);
 }
 
-double1d_t FourierTransform::ifftshift(const double1d_t& src)
+std::vector<double> FourierTransform::ifftshift(const std::vector<double>& src)
 {
     return ::fftshift_1d(src, true);
 }
-complex1d_t FourierTransform::ifftshift(const complex1d_t& src)
+std::vector<complex_t> FourierTransform::ifftshift(const std::vector<complex_t>& src)
 {
     return ::fftshift_1d(src, true);
 }
@@ -255,7 +254,7 @@ complex2d_t FourierTransform::rfft2complex_vec() const
 {
     ASSERT(ws.arr_fftw);
 
-    complex2d_t result(ws.h, complex1d_t(ws.w_fftw));
+    complex2d_t result(ws.h, std::vector<complex_t>(ws.w_fftw));
     double* ptr = ws.arr_fftw;
 
     // Storing FT output
diff --git a/Base/Math/FourierTransform.h b/Base/Math/FourierTransform.h
index 43fc3518eaa846c7c00c02dab0655d8e2f32e9f2..7e4ef0750515aa86196e686703baaa4072617c5c 100644
--- a/Base/Math/FourierTransform.h
+++ b/Base/Math/FourierTransform.h
@@ -18,7 +18,7 @@
 #ifndef BORNAGAIN_BASE_MATH_FOURIERTRANSFORM_H
 #define BORNAGAIN_BASE_MATH_FOURIERTRANSFORM_H
 
-#include "Base/Type/Vector.h"
+#include "Base/Type/Field2D.h"
 #include <fftw3.h>
 
 //! Fourier transform of vectors (in 1D or 2D) using Fast Fourier Transform (fftw package).
@@ -27,15 +27,15 @@ public:
     FourierTransform();
 
     // forward transform
-    complex1d_t rfft(const double1d_t& src);
+    std::vector<complex_t> rfft(const std::vector<double>& src);
     complex2d_t rfft(const double2d_t& src);
 
     // forward transform with real-valued amplitudes in output
-    double1d_t ramplitude(const double1d_t& src);
+    std::vector<double> ramplitude(const std::vector<double>& src);
     double2d_t ramplitude(const double2d_t& src);
 
     // backward transform
-    double1d_t irfft(const complex1d_t& src, int w_src);
+    std::vector<double> irfft(const std::vector<complex_t>& src, int w_src);
     double2d_t irfft(const complex2d_t& src, int w_real);
 
     // Frequency shifts are useful for providing different representations of spectrum: with lowest
@@ -43,14 +43,14 @@ public:
     // array
 
     // shift low frequency from corners to center
-    static double1d_t fftshift(const double1d_t& src);
-    static complex1d_t fftshift(const complex1d_t& src);
+    static std::vector<double> fftshift(const std::vector<double>& src);
+    static std::vector<complex_t> fftshift(const std::vector<complex_t>& src);
     static double2d_t fftshift(const double2d_t& src);
     static complex2d_t fftshift(const complex2d_t& src);
 
     // shift low frequency from center to corners
-    static double1d_t ifftshift(const double1d_t& src);
-    static complex1d_t ifftshift(const complex1d_t& src);
+    static std::vector<double> ifftshift(const std::vector<double>& src);
+    static std::vector<complex_t> ifftshift(const std::vector<complex_t>& src);
     static double2d_t ifftshift(const double2d_t& src);
     static complex2d_t ifftshift(const complex2d_t& src);
 
diff --git a/Base/Type/Field2D.h b/Base/Type/Field2D.h
new file mode 100644
index 0000000000000000000000000000000000000000..e4715072ea0c543a0ac040ab2d459b03b74882d0
--- /dev/null
+++ b/Base/Type/Field2D.h
@@ -0,0 +1,56 @@
+//  ************************************************************************************************
+//
+//  BornAgain: simulate and fit reflection and scattering
+//
+//! @file      Base/Type/Field2D.h
+//! @brief     Defines two-dimensional data arrays.
+//!
+//! @homepage  http://www.bornagainproject.org
+//! @license   GNU General Public License v3 or higher (see COPYING)
+//! @copyright Forschungszentrum Jülich GmbH 2024
+//! @authors   Scientific Computing Group at MLZ (see CITATION, AUTHORS)
+//
+//  ************************************************************************************************
+
+#ifndef BORNAGAIN_BASE_TYPE_FIELD2D_H
+#define BORNAGAIN_BASE_TYPE_FIELD2D_H
+
+#include <functional>
+#include <heinz/Complex.h>
+#include <vector>
+
+template <typename T> using Field2D = std::vector<std::vector<T>>;
+
+using double2d_t = Field2D<double>;
+using complex2d_t = Field2D<complex_t>;
+
+namespace FieldUtil {
+
+template <typename T> std::vector<T> flatten(const Field2D<T>& src)
+{
+    std::vector<T> result;
+    for (const auto& row : src)
+        result.insert(result.end(), row.begin(), row.end());
+    return result;
+}
+
+template <typename T>
+Field2D<T> make(size_t n_rows, size_t n_cols, std::function<T(size_t, size_t)> setter)
+{
+    Field2D<T> result(n_rows, std::vector<T>(n_cols));
+    for (size_t i = 0; i < n_rows; i++)
+        for (size_t j = 0; j < n_cols; j++)
+            result[i][j] = setter(i, j);
+    return result;
+}
+
+template <typename T> Field2D<T> reshapeTo2D(const std::vector<T>& src, size_t n_rows)
+{
+    size_t n_cols = src.size() / n_rows;
+    return make<T>(n_rows, n_cols,
+                   [&src, n_cols](size_t i, size_t j) -> T { return src[i * n_cols + j]; });
+}
+
+} // namespace FieldUtil
+
+#endif // BORNAGAIN_BASE_TYPE_FIELD2D_H
diff --git a/Base/Type/Vector.h b/Base/Type/Vector.h
deleted file mode 100644
index ccb2b368c1df02de54e8d09ed9644a7aaf234f76..0000000000000000000000000000000000000000
--- a/Base/Type/Vector.h
+++ /dev/null
@@ -1,26 +0,0 @@
-//  ************************************************************************************************
-//
-//  BornAgain: simulate and fit reflection and scattering
-//
-//! @file      Base/Type/Vector.h
-//! @brief     Defines vector types.
-//!
-//! @homepage  http://www.bornagainproject.org
-//! @license   GNU General Public License v3 or higher (see COPYING)
-//! @copyright Forschungszentrum Jülich GmbH 2024
-//! @authors   Scientific Computing Group at MLZ (see CITATION, AUTHORS)
-//
-//  ************************************************************************************************
-
-#ifndef BORNAGAIN_BASE_TYPE_VECTOR_H
-#define BORNAGAIN_BASE_TYPE_VECTOR_H
-
-#include <heinz/Complex.h>
-#include <vector>
-
-using double1d_t = std::vector<double>;
-using double2d_t = std::vector<double1d_t>;
-using complex1d_t = std::vector<complex_t>;
-using complex2d_t = std::vector<complex1d_t>;
-
-#endif // BORNAGAIN_BASE_TYPE_VECTOR_H
diff --git a/Base/Util/Vec.h b/Base/Util/Vec.h
index 3c29800467588145da5d490f535a098952e91a7b..5b8e20dfcc15fa72ecee2817025cd5dfa22d4371 100644
--- a/Base/Util/Vec.h
+++ b/Base/Util/Vec.h
@@ -40,25 +40,6 @@ template <typename C> void concat(std::vector<C>& v, const std::vector<C>& w)
     v.insert(v.end(), w.begin(), w.end());
 }
 
-template <typename C> std::vector<C> flatten(const std::vector<std::vector<C>>& src)
-{
-    std::vector<C> result;
-    for (const auto& row : src)
-        result.insert(result.end(), row.begin(), row.end());
-    return result;
-}
-
-template <typename C>
-std::vector<std::vector<C>> reshapeTo2D(const std::vector<C>& src, size_t n_rows)
-{
-    size_t n_cols = src.size() / n_rows;
-    std::vector<std::vector<C>> result(n_rows);
-
-    for (size_t i = 0; i < n_rows; i++)
-        result[i].insert(result[i].end(), src.begin() + i * n_cols, src.begin() + (i + 1) * n_cols);
-    return result;
-}
-
 } // namespace Vec
 
 #endif // BORNAGAIN_BASE_UTIL_VEC_H
diff --git a/Device/Analyze/Fourier.cpp b/Device/Analyze/Fourier.cpp
index b3ec5f790854da5c1f9bf10153660c541876a0ee..232d774a30a8c3febeefc6971cb6c9f22dc4c884 100644
--- a/Device/Analyze/Fourier.cpp
+++ b/Device/Analyze/Fourier.cpp
@@ -24,7 +24,7 @@ Datafield Analyze::createFFT(const Datafield& data)
     const auto signal = data.values2D();
 
     FourierTransform ft;
-    std::vector<std::vector<double>> signal2 = ft.ramplitude(signal);
+    double2d_t signal2 = ft.ramplitude(signal);
     signal2 = ft.fftshift(signal2); // low frequency to center of array
 
     return {"~" + data.xAxis().axisLabel(), "~" + data.yAxis().axisLabel(), signal2};
diff --git a/Device/Analyze/Peaks.cpp b/Device/Analyze/Peaks.cpp
index fc012a565454917a43301d7604b181f641f0b36b..f0d8078dd88959cb6e7cb2ee7776eb10596ad6cd 100644
--- a/Device/Analyze/Peaks.cpp
+++ b/Device/Analyze/Peaks.cpp
@@ -21,7 +21,7 @@
 std::vector<std::pair<double, double>>
 Analyze::FindPeaks(const Datafield& data, double sigma, const std::string& option, double threshold)
 {
-    const std::vector<std::vector<double>> arr = data.values2D();
+    const double2d_t arr = data.values2D();
     tspectrum::Spectrum2D spec;
     const auto peaks = spec.find_peaks(arr, sigma, option, threshold);
 
diff --git a/Device/Data/DataUtil.cpp b/Device/Data/DataUtil.cpp
index e842c755eca50f7aaf4784b88787cdf9694e5520..06db72b4701acbc84e91b3c875bb9eada7e726ad 100644
--- a/Device/Data/DataUtil.cpp
+++ b/Device/Data/DataUtil.cpp
@@ -21,10 +21,9 @@
 #include <algorithm>
 #include <cmath>
 
-std::vector<std::vector<double>>
-DataUtil::invertAxis(int axis, const std::vector<std::vector<double>>& original)
+double2d_t DataUtil::invertAxis(int axis, const double2d_t& original)
 {
-    std::vector<std::vector<double>> inverse = original;
+    double2d_t inverse = original;
 
     const size_t orig_rows = original.size();
 
@@ -43,15 +42,14 @@ DataUtil::invertAxis(int axis, const std::vector<std::vector<double>>& original)
     return inverse;
 }
 
-std::vector<std::vector<double>>
-DataUtil::transpose(const std::vector<std::vector<double>>& original)
+double2d_t DataUtil::transpose(const double2d_t& original)
 {
     ASSERT(!original.empty());
 
     const size_t orig_rows = original.size();
     const size_t orig_cols = original.front().size();
 
-    std::vector<std::vector<double>> transposed(orig_cols, std::vector<double>(orig_rows));
+    double2d_t transposed(orig_cols, std::vector<double>(orig_rows));
 
     for (size_t i = 0; i < orig_rows; ++i)
         for (size_t j = 0; j < orig_cols; ++j)
diff --git a/Device/Data/DataUtil.h b/Device/Data/DataUtil.h
index 5b30b829259992667d99426726f2d5b3a3fa324c..fe7dee302f87c41f30c7ea3838feb41c5bc98c59 100644
--- a/Device/Data/DataUtil.h
+++ b/Device/Data/DataUtil.h
@@ -18,6 +18,7 @@
 #ifndef BORNAGAIN_DEVICE_DATA_DATAUTIL_H
 #define BORNAGAIN_DEVICE_DATA_DATAUTIL_H
 
+#include "Base/Type/Field2D.h"
 #include <string>
 #include <vector>
 
@@ -32,14 +33,13 @@ namespace DataUtil {
 Datafield rotatedDatafield(const Datafield& data, int n);
 
 //! Changes the direction of rows or columns
-std::vector<std::vector<double>> invertAxis(int axis,
-                                            const std::vector<std::vector<double>>& original);
+double2d_t invertAxis(int axis, const double2d_t& original);
 
 //! Transposes the matrix
-std::vector<std::vector<double>> transpose(const std::vector<std::vector<double>>& original);
+double2d_t transpose(const double2d_t& original);
 
 //! Creates a vector of vectors of double (2D Array) from Datafield.
-std::vector<std::vector<double>> create2DArrayfromDatafield(const Datafield& data);
+double2d_t create2DArrayfromDatafield(const Datafield& data);
 
 //! Returns Datafield representing relative difference of two histograms.
 Datafield relativeDifferenceField(const Datafield& dat, const Datafield& ref);
diff --git a/Device/Data/Datafield.cpp b/Device/Data/Datafield.cpp
index 4655dd07783ef7c5e9ef7f5e2ae449044fa70766..d1eeee12421911e02777a38427a0d0a5c98e06d8 100644
--- a/Device/Data/Datafield.cpp
+++ b/Device/Data/Datafield.cpp
@@ -85,8 +85,7 @@ Datafield::Datafield(const std::vector<const Scale*>& axes)
 {
 }
 
-Datafield::Datafield(const std::string& xlabel, const std::string& ylabel,
-                     const std::vector<std::vector<double>>& vec)
+Datafield::Datafield(const std::string& xlabel, const std::string& ylabel, const double2d_t& vec)
 {
     const size_t nrows = vec.size();
     const size_t ncols = vec[0].size();
@@ -165,19 +164,9 @@ void Datafield::setVector(const std::vector<double>& vector)
     m_values = vector;
 }
 
-void Datafield::setVector2D(const std::vector<std::vector<double>>& in)
+void Datafield::setVector2D(const double2d_t& in)
 {
-    const size_t ncols = axis(0).size();
-    const size_t nrows = axis(1).size();
-
-    ASSERT(in.size() == nrows);
-    m_values.clear();
-    m_values.reserve(nrows * ncols);
-    for (size_t j = 0; j < nrows; ++j) {
-        ASSERT(in[j].size() == ncols);
-        for (size_t i = 0; i < ncols; ++i)
-            m_values.push_back(in[j][i]);
-    }
+    m_values = FieldUtil::flatten(in);
 }
 
 size_t Datafield::rank() const
@@ -422,21 +411,7 @@ Datafield Datafield::normalizedToMax() const
     return {title(), frame().clone(), outval, errval};
 }
 
-std::vector<std::vector<double>> Datafield::values2D() const
+double2d_t Datafield::values2D() const
 {
-    ASSERT(rank() == 2);
-    std::vector<std::vector<double>> result;
-
-    const size_t nrows = axis(1).size();
-    const size_t ncols = axis(0).size();
-
-    result.resize(nrows);
-
-    for (size_t row = 0; row < nrows; ++row) {
-        result[row].resize(ncols, 0.0);
-        for (size_t col = 0; col < ncols; ++col)
-            result[row][col] = m_values[row * ncols + col];
-    }
-
-    return result;
+    return FieldUtil::reshapeTo2D(m_values, axis(1).size());
 }
diff --git a/Device/Data/Datafield.h b/Device/Data/Datafield.h
index c50e40f3898a907e0e0d268172a76c7cc6efce8c..6a900a570b87c85f5f8d4d8cafcc6074a3a0053c 100644
--- a/Device/Data/Datafield.h
+++ b/Device/Data/Datafield.h
@@ -15,6 +15,7 @@
 #ifndef BORNAGAIN_DEVICE_DATA_DATAFIELD_H
 #define BORNAGAIN_DEVICE_DATA_DATAFIELD_H
 
+#include "Base/Type/Field2D.h"
 #include <memory>
 #include <string>
 #include <vector>
@@ -51,8 +52,7 @@ public:
     Datafield(const std::vector<const Scale*>& axes);
 
     //! Constructor that creates equidistant grid from 2D array.
-    Datafield(const std::string& xlabel, const std::string& ylabel,
-              const std::vector<std::vector<double>>& vec);
+    Datafield(const std::string& xlabel, const std::string& ylabel, const double2d_t& vec);
 
     Datafield(const Datafield&);
 #ifndef SWIG
@@ -155,7 +155,7 @@ public:
 
     //! Sets new values to raw data vector.
     void setVector(const std::vector<double>& data_vector);
-    void setVector2D(const std::vector<std::vector<double>>& in);
+    void setVector2D(const double2d_t& in);
 
     bool hasErrorSigmas() const;
     std::vector<double>& errorSigmas()
@@ -163,7 +163,7 @@ public:
         return m_err_sigmas;
     }
 
-    std::vector<std::vector<double>> values2D() const;
+    double2d_t values2D() const;
 
 private:
     std::string m_title;
diff --git a/Device/IO/ReadReflectometry.cpp b/Device/IO/ReadReflectometry.cpp
index 7807a794440d5d7f814b97c1734ba77bc483df95..333f9bcaeca0b195ffb41376cce909cf06e3f8cd 100644
--- a/Device/IO/ReadReflectometry.cpp
+++ b/Device/IO/ReadReflectometry.cpp
@@ -37,7 +37,7 @@ Datafield Util::RW::readReflectometryTable(std::istream& s, const ImportSettings
     std::string line;
     int lineno = 0;
 
-    std::vector<std::vector<double>> rowsVec;
+    double2d_t rowsVec;
 
     // Read numbers from file:
     while (std::getline(s, line)) {
diff --git a/Device/IO/ReadWrite2DTable.cpp b/Device/IO/ReadWrite2DTable.cpp
index 51282614b670fc2377305e87bd6d67120e20a835..3d95d18a79bbb0d934f1ce79de243983d34ecaef 100644
--- a/Device/IO/ReadWrite2DTable.cpp
+++ b/Device/IO/ReadWrite2DTable.cpp
@@ -56,7 +56,7 @@ void write2DRepresentation(const Datafield& data, std::ostream& output_stream)
 
     output_stream << "# [nrows=" << nrows << ", ncols=" << ncols << "]" << std::endl;
 
-    std::vector<std::vector<double>> dataArray = data.values2D();
+    double2d_t dataArray = data.values2D();
     output_stream.imbue(std::locale::classic());
     output_stream << std::scientific << std::setprecision(12);
 
@@ -83,10 +83,10 @@ bool getNextLine(std::istream& input_stream, std::string& line)
     return false;
 }
 
-std::vector<std::vector<double>> parseFile(std::istream& input_stream)
+double2d_t parseFile(std::istream& input_stream)
 {
     std::string line;
-    std::vector<std::vector<double>> data;
+    double2d_t data;
 
     // Read numbers from input stream:
     size_t nrows = 0;
@@ -105,7 +105,7 @@ std::vector<std::vector<double>> parseFile(std::istream& input_stream)
 
 Datafield readBareIntensity(std::istream& input_stream)
 {
-    std::vector<std::vector<double>> data = parseFile(input_stream);
+    double2d_t data = parseFile(input_stream);
     size_t nrows = data.size();
     size_t ncols = nrows ? data[0].size() : 0;
 
@@ -143,7 +143,7 @@ Datafield Util::RW::read2DTable(std::istream& input_stream, const ImportSettings
         return readBareIntensity(input_stream);
 
     // read table with axes info
-    std::vector<std::vector<double>> data = parseFile(input_stream);
+    double2d_t data = parseFile(input_stream);
     size_t nrows = data.size();
     size_t ncols = nrows ? data.front().size() : 0;
 
diff --git a/Device/Resolution/ConvolutionDetectorResolution.cpp b/Device/Resolution/ConvolutionDetectorResolution.cpp
index ea45fc45bc123a58057f763ccb5f51194659675c..016f848156aa8a485cf3dea3ba1be76b59078f71 100644
--- a/Device/Resolution/ConvolutionDetectorResolution.cpp
+++ b/Device/Resolution/ConvolutionDetectorResolution.cpp
@@ -109,7 +109,7 @@ void ConvolutionDetectorResolution::apply2dConvolution(Datafield* df) const
         return;
 
     // Construct kernel vector from resolution function
-    std::vector<std::vector<double>> kernel;
+    double2d_t kernel;
     kernel.resize(ny);
     double mid_value1 = X.binCenter(nx / 2); // because Convolve expects zero at midpoint
     double mid_value2 = Y.binCenter(ny / 2); // because Convolve expects zero at midpoint
@@ -127,7 +127,7 @@ void ConvolutionDetectorResolution::apply2dConvolution(Datafield* df) const
     }
 
     // Calculate convolution
-    std::vector<std::vector<double>> result;
+    double2d_t result;
     Convolve().fftconvolve2D(df->values2D(), kernel, result);
 
     df->setVector2D(result);
diff --git a/Device/Resolution/Convolve.cpp b/Device/Resolution/Convolve.cpp
index 4ceed5e6c2141954acb8882cd87f932ffd8d5915..a85af775d25a2c7dcc0fb528ba8096eec0856a0d 100644
--- a/Device/Resolution/Convolve.cpp
+++ b/Device/Resolution/Convolve.cpp
@@ -118,7 +118,8 @@ void Convolve::fftconvolve2D(const double2d_t& source, const double2d_t& kernel,
     }
 }
 
-void Convolve::fftconvolve1D(const double1d_t& source, const double1d_t& kernel, double1d_t& result)
+void Convolve::fftconvolve1D(const std::vector<double>& source, const std::vector<double>& kernel,
+                             std::vector<double>& result)
 {
     // we simply create 2d arrays with length of first dimension equal to 1, and call 2d convolution
     double2d_t source2d, kernel2d;
diff --git a/Device/Resolution/Convolve.h b/Device/Resolution/Convolve.h
index 0e3c3bfd5e8104b22f2f32245921c6c9a653f6b3..cd77a87ed471f5068b6fac36d34e3b188842a4ff 100644
--- a/Device/Resolution/Convolve.h
+++ b/Device/Resolution/Convolve.h
@@ -18,7 +18,7 @@
 #ifndef BORNAGAIN_DEVICE_RESOLUTION_CONVOLVE_H
 #define BORNAGAIN_DEVICE_RESOLUTION_CONVOLVE_H
 
-#include "Base/Type/Vector.h"
+#include "Base/Type/Field2D.h"
 #include <fftw3.h>
 
 //! Convolution of two real vectors (in 1D or 2D) using Fast Fourier Transform.
@@ -51,7 +51,8 @@ public:
     };
 
     //! convolution in 1D
-    void fftconvolve1D(const double1d_t& source, const double1d_t& kernel, double1d_t& result);
+    void fftconvolve1D(const std::vector<double>& source, const std::vector<double>& kernel,
+                       std::vector<double>& result);
 
     //! convolution in 2D
     void fftconvolve2D(const double2d_t& source, const double2d_t& kernel, double2d_t& result);
diff --git a/Fit/Adapter/MinimizerAdapter.cpp b/Fit/Adapter/MinimizerAdapter.cpp
index ea0cbfbca404604773a514ac42ebab3956ab38e3..badf1ab68f98fb778ca5251eef8cabdc42c9d8f3 100644
--- a/Fit/Adapter/MinimizerAdapter.cpp
+++ b/Fit/Adapter/MinimizerAdapter.cpp
@@ -124,16 +124,11 @@ void MinimizerAdapter::propagateResults(mumufit::Parameters& parameters)
     parameters.setErrors(parErrorsAtMinimum());
     // sets correlation matrix
     if (providesError()) {
-        mumufit::Parameters::corr_matrix_t matrix;
-        matrix.resize(fitRank());
-
-        for (size_t i = 0; i < fitRank(); ++i) {
-            matrix[i].resize(fitRank(), 0.0);
-            for (size_t j = 0; j < fitRank(); ++j)
-                matrix[i][j] = rootMinimizer()->Correlation(static_cast<unsigned int>(i),
-                                                            static_cast<unsigned int>(j));
-        }
-        parameters.setCorrelationMatrix(matrix);
+	auto lambda = [&](size_t i, size_t j) -> double
+	    { return rootMinimizer()->Correlation(static_cast<unsigned int>(i),
+						  static_cast<unsigned int>(j)); };
+	double2d_t matrix = FieldUtil::make<double>(fitRank(), fitRank(), lambda);
+	parameters.setCorrelationMatrix(matrix);
     }
 }
 
diff --git a/Fit/CMakeLists.txt b/Fit/CMakeLists.txt
index bf8f254163af8df010f5e6cee9f9e67d93914216..fec01a45a33b9ac1580fdb7bfc68fdefe373b623 100644
--- a/Fit/CMakeLists.txt
+++ b/Fit/CMakeLists.txt
@@ -27,8 +27,9 @@ target_link_libraries(${lib}
 target_include_directories(${lib}
     PUBLIC
     ${CMAKE_SOURCE_DIR}
-    SYSTEM PUBLIC # because needed by Fit/Test/Unit
-    ${Boost_INCLUDE_DIRS}
+    SYSTEM PUBLIC
+    ${LibHeinz_INCLUDE_DIR}
+    ${Boost_INCLUDE_DIRS}  # because needed by Fit/Test/Unit ?
     SYSTEM PRIVATE
     ${RootMinimizers_INCLUDE_DIRS}
     )
diff --git a/Fit/Minimizer/MinimizerResult.cpp b/Fit/Minimizer/MinimizerResult.cpp
index 388fdda5c5552edb82f7046b5401416655f69ec9..fa5399ade6e87503bafd9763d2fb440bf7d00b49 100644
--- a/Fit/Minimizer/MinimizerResult.cpp
+++ b/Fit/Minimizer/MinimizerResult.cpp
@@ -33,7 +33,7 @@ std::string reportParameters(const mumufit::Parameters& parameters)
                       % par.startValue() % par.limits().toString() % par.value() % par.error();
     }
 
-    mumufit::Parameters::corr_matrix_t matrix = parameters.correlationMatrix();
+    double2d_t matrix = parameters.correlationMatrix();
     if (!matrix.empty()) {
         result << mumufit::utils::sectionString("Correlations");
         for (size_t i = 0; i < matrix.size(); ++i) {
diff --git a/Fit/Param/Parameters.cpp b/Fit/Param/Parameters.cpp
index 12df12a211610e381f6fff9a9184366f3572af2a..3f1c20d548e4be3f478d2ad84b8806dfb3b2643c 100644
--- a/Fit/Param/Parameters.cpp
+++ b/Fit/Param/Parameters.cpp
@@ -114,12 +114,12 @@ const Parameter& Parameters::operator[](size_t index) const
     return m_parameters[check_index(index)];
 }
 
-Parameters::corr_matrix_t Parameters::correlationMatrix() const
+double2d_t Parameters::correlationMatrix() const
 {
     return m_corr_matrix;
 }
 
-void Parameters::setCorrelationMatrix(const Parameters::corr_matrix_t& matrix)
+void Parameters::setCorrelationMatrix(const double2d_t& matrix)
 {
     if (matrix.size() != size())
         throw std::runtime_error("Parameters::setCorrelationMatrix -> Error. Wrong "
diff --git a/Fit/Param/Parameters.h b/Fit/Param/Parameters.h
index f71f197361f3d25b3f4e93cfc0643156204e5698..f038fc4fae402854624038a40e8602ea1ebffb83 100644
--- a/Fit/Param/Parameters.h
+++ b/Fit/Param/Parameters.h
@@ -15,6 +15,7 @@
 #ifndef BORNAGAIN_FIT_PARAM_PARAMETERS_H
 #define BORNAGAIN_FIT_PARAM_PARAMETERS_H
 
+#include "Base/Type/Field2D.h"
 #include "Fit/Param/Parameter.h"
 #include <vector>
 
@@ -27,7 +28,6 @@ public:
     using parameters_t = std::vector<Parameter>;
     using const_iterator = parameters_t::const_iterator;
     using iterator = parameters_t::iterator;
-    using corr_matrix_t = std::vector<std::vector<double>>;
 
     Parameters() = default;
 
@@ -50,8 +50,8 @@ public:
     const Parameter& operator[](const std::string& name) const;
     const Parameter& operator[](size_t index) const;
 
-    corr_matrix_t correlationMatrix() const;
-    void setCorrelationMatrix(const corr_matrix_t& matrix);
+    double2d_t correlationMatrix() const;
+    void setCorrelationMatrix(const double2d_t& matrix);
 
     size_t freeParameterCount() const;
 
@@ -61,7 +61,7 @@ private:
     size_t check_index(size_t index) const;
 
     parameters_t m_parameters;
-    corr_matrix_t m_corr_matrix; //!< correlation matrix
+    double2d_t m_corr_matrix; //!< correlation matrix
 };
 
 } // namespace mumufit
diff --git a/Fit/Residual/ResidualFunctionAdapter.cpp b/Fit/Residual/ResidualFunctionAdapter.cpp
index 58cdfbfb03f76fa37aac555f3f15f7502cf3d8da..6f189f30b47ddf5c7e08bd0f213f9c99a45f1c6f 100644
--- a/Fit/Residual/ResidualFunctionAdapter.cpp
+++ b/Fit/Residual/ResidualFunctionAdapter.cpp
@@ -55,10 +55,7 @@ const RootResidualFunction* ResidualFunctionAdapter::rootResidualFunction()
 
 void ResidualFunctionAdapter::calculate_gradients(const std::vector<double>& pars)
 {
-    m_gradients.clear();
-    m_gradients.resize(pars.size());
-    for (size_t i_par = 0; i_par < pars.size(); ++i_par)
-        m_gradients[i_par].resize(m_datasize, 0.0);
+    m_gradients.resize(pars.size(), std::vector<double>(m_datasize));
 
     auto residuals = get_residuals(pars);
     m_number_of_gradient_calls++;
diff --git a/Fit/Residual/ResidualFunctionAdapter.h b/Fit/Residual/ResidualFunctionAdapter.h
index d696eec24f161f2ad225f7bf03c8e5e8f4c6eb6f..ebba0b3cb2dd5a6505abfc74d6559e9614f6f2e5 100644
--- a/Fit/Residual/ResidualFunctionAdapter.h
+++ b/Fit/Residual/ResidualFunctionAdapter.h
@@ -53,7 +53,7 @@ private:
     fcn_residual_t m_fcn; //!< user function to minimize
     Parameters m_parameters;
     std::vector<double> m_residuals;
-    std::vector<std::vector<double>> m_gradients; // [m_npars][m_ndatasize]
+    double2d_t m_gradients; // [m_npars][m_ndatasize]
     std::unique_ptr<RootResidualFunction> m_root_objective;
 };
 
diff --git a/GUI/View/Realspace/RealspaceBuilder.cpp b/GUI/View/Realspace/RealspaceBuilder.cpp
index d575e5af57f45e0da86f4a8c9c1b05ff6c216de6..de519cc37c8b28489abc01eefc5bf2b5cee9a383 100644
--- a/GUI/View/Realspace/RealspaceBuilder.cpp
+++ b/GUI/View/Realspace/RealspaceBuilder.cpp
@@ -43,7 +43,6 @@ using Img3D::Model;
 using Img3D::Particle3DContainer;
 
 namespace {
-using double2d_t = RealspaceBuilder::double2d_t;
 
 double2d_t generatePositions(IInterference* const iff, double layerSize, double density)
 {
@@ -86,15 +85,9 @@ double visualLayerThickness(const LayerItem& layerItem, const SceneGeometry& sce
 std::unique_ptr<double2d_t> scaledArray(const double2d_t& src, double factor)
 {
     ASSERT(src.size());
-
-    std::unique_ptr<double2d_t> result =
-        std::make_unique<double2d_t>(src.size(), std::vector<double>(src[0].size()));
-
-    for (size_t i = 0; i < src.size(); i++)
-        for (size_t j = 0; j < src[0].size(); j++)
-            (*result)[i][j] = src[i][j] * factor;
-
-    return result;
+    return std::make_unique<double2d_t>(
+        FieldUtil::make<double>(src.size(), src[0].size(),
+                                [&src, factor](size_t i, size_t j) { return src[i][j] * factor; }));
 }
 
 std::unique_ptr<const double2d_t> layerRoughnessMap(const LayerItem& layerItem,
@@ -315,7 +308,7 @@ void RealspaceBuilder::translateContainer(Model* model,
 }
 
 void RealspaceBuilder::populateParticlesInLattice(
-    const std::vector<std::vector<double>>& lattice_positions,
+    const double2d_t& lattice_positions,
     const std::vector<Particle3DContainer>& particle3DContainer_vector, Model* model,
     const SceneGeometry& sceneGeometry, unsigned& numParticles) const
 {
diff --git a/GUI/View/Realspace/RealspaceBuilder.h b/GUI/View/Realspace/RealspaceBuilder.h
index aaccbea06b3289443f8b374dcdd0cb5fec372649..858af20c990339d1a497f515e6bfb200173b30b8 100644
--- a/GUI/View/Realspace/RealspaceBuilder.h
+++ b/GUI/View/Realspace/RealspaceBuilder.h
@@ -15,6 +15,7 @@
 #ifndef BORNAGAIN_GUI_VIEW_REALSPACE_REALSPACEBUILDER_H
 #define BORNAGAIN_GUI_VIEW_REALSPACE_REALSPACEBUILDER_H
 
+#include "Base/Type/Field2D.h"
 #include "Img3D/View/Camera.h"
 
 class Item3D;
@@ -32,8 +33,6 @@ class Particle3DContainer;
 
 class RealspaceBuilder {
 public:
-    using double2d_t = std::vector<std::vector<double>>;
-
     RealspaceBuilder(std::function<QColor(const QString&)> fnColorFromMaterialName);
     ~RealspaceBuilder();
 
@@ -70,7 +69,7 @@ private:
                             unsigned& numParticles, const Img3D::F3& lattice_position = {}) const;
 
     void populateParticlesInLattice(
-        const std::vector<std::vector<double>>& lattice_positions,
+        const double2d_t& lattice_positions,
         const std::vector<Img3D::Particle3DContainer>& particle3DContainer_vector,
         Img3D::Model* model, const SceneGeometry& sceneGeometry, unsigned& numParticles) const;
 };
diff --git a/Img3D/Build/ParacrystalLatticePositions.cpp b/Img3D/Build/ParacrystalLatticePositions.cpp
index 8c4553ffe4631e48238c02175f7bb34430694e75..e4730cbfb6dfc6f891fbb50b89d742b15074ff7c 100644
--- a/Img3D/Build/ParacrystalLatticePositions.cpp
+++ b/Img3D/Build/ParacrystalLatticePositions.cpp
@@ -18,8 +18,7 @@
 
 namespace {
 
-void ResizeLatticePositions(std::vector<std::vector<double>>& lattice_positions, double l1,
-                            double l2, double layer_size)
+void ResizeLatticePositions(double2d_t& lattice_positions, double l1, double l2, double layer_size)
 {
     // Estimate the limit n1 and n2 of the integer multiple j and i of the lattice vectors l1 and l2
     // required for populating particles correctly within the 3D model's boundaries
@@ -58,9 +57,10 @@ void FindLatticePositionsIndex(size_t& index, size_t& index_prev, int i, int j,
     }
 }
 
-std::pair<double, double> ComputePositionAlongPositiveLatticeVector(
-    const size_t index_prev, std::vector<std::vector<double>>& lattice_positions,
-    const IProfile2D* pdf, double l, double l_xi, double l_alpha)
+std::pair<double, double> ComputePositionAlongPositiveLatticeVector(const size_t index_prev,
+                                                                    double2d_t& lattice_positions,
+                                                                    const IProfile2D* pdf, double l,
+                                                                    double l_xi, double l_alpha)
 {
     double gamma_pdf = pdf->gamma();
     std::pair<double, double> sampleXYpdf = pdf->createSampler()->randomSample();
@@ -78,9 +78,10 @@ std::pair<double, double> ComputePositionAlongPositiveLatticeVector(
     return std::make_pair(x, y);
 }
 
-std::pair<double, double> ComputePositionAlongNegativeLatticeVector(
-    const size_t index_prev, std::vector<std::vector<double>>& lattice_positions,
-    const IProfile2D* pdf, double l, double l_xi, double l_alpha)
+std::pair<double, double> ComputePositionAlongNegativeLatticeVector(const size_t index_prev,
+                                                                    double2d_t& lattice_positions,
+                                                                    const IProfile2D* pdf, double l,
+                                                                    double l_xi, double l_alpha)
 {
     double gamma_pdf = pdf->gamma();
     std::pair<double, double> sampleXYpdf = pdf->createSampler()->randomSample();
@@ -98,10 +99,10 @@ std::pair<double, double> ComputePositionAlongNegativeLatticeVector(
     return std::make_pair(x, y);
 }
 
-std::pair<double, double>
-ComputeLatticePosition(const size_t index_prev, int i, int j,
-                       std::vector<std::vector<double>>& lattice_positions, const IProfile2D* pdf,
-                       double l, double l_xi, double l_alpha)
+std::pair<double, double> ComputeLatticePosition(const size_t index_prev, int i, int j,
+                                                 double2d_t& lattice_positions,
+                                                 const IProfile2D* pdf, double l, double l_xi,
+                                                 double l_alpha)
 {
     if (std::sin(l_alpha) == 0) {
         if (!(j % 2 == 0)) // along +l1
@@ -119,9 +120,8 @@ ComputeLatticePosition(const size_t index_prev, int i, int j,
                                                      l_alpha);
 }
 
-void ComputePositionsAlongLatticeVectorAxes(std::vector<std::vector<double>>& lattice_positions,
-                                            const IProfile2D* pdf, double l, double l_xi,
-                                            double l_alpha)
+void ComputePositionsAlongLatticeVectorAxes(double2d_t& lattice_positions, const IProfile2D* pdf,
+                                            double l, double l_xi, double l_alpha)
 {
     int n = static_cast<int>((std::sqrt(lattice_positions.size()) - 1) / 2);
 
@@ -156,9 +156,9 @@ void ComputePositionsAlongLatticeVectorAxes(std::vector<std::vector<double>>& la
     }
 }
 
-void ComputePositionsInsideLatticeQuadrants(std::vector<std::vector<double>>& lattice_positions,
-                                            const IProfile2D* pdf1, const IProfile2D* pdf2,
-                                            double l1, double l2, double l_xi, double l_alpha)
+void ComputePositionsInsideLatticeQuadrants(double2d_t& lattice_positions, const IProfile2D* pdf1,
+                                            const IProfile2D* pdf2, double l1, double l2,
+                                            double l_xi, double l_alpha)
 {
     int n = static_cast<int>((std::sqrt(lattice_positions.size()) - 1) / 2);
 
@@ -189,8 +189,7 @@ void ComputePositionsInsideLatticeQuadrants(std::vector<std::vector<double>>& la
 //  implement namespace Img3D::Paracrystal2D
 //  ************************************************************************************************
 
-std::vector<std::vector<double>>
-Paracrystal::latticePositions(const Interference2DParacrystal* p_iff, double layer_size)
+double2d_t Paracrystal::latticePositions(const Interference2DParacrystal* p_iff, double layer_size)
 {
     const auto& lattice = p_iff->lattice();
     double l1 = lattice.length1();
@@ -198,7 +197,7 @@ Paracrystal::latticePositions(const Interference2DParacrystal* p_iff, double lay
     double alpha = lattice.latticeAngle();
     double xi = lattice.rotationAngle();
 
-    std::vector<std::vector<double>> lattice_positions;
+    double2d_t lattice_positions;
     ResizeLatticePositions(lattice_positions, l1, l2, layer_size);
 
     ComputePositionsAlongLatticeVectorAxes(lattice_positions, p_iff->pdf1(), l1, xi, 0);
diff --git a/Img3D/Build/ParacrystalLatticePositions.h b/Img3D/Build/ParacrystalLatticePositions.h
index ba89b2b9ed376ff08e12b5686f95284e6cecb863..1195cd8f1d12adafb1f2f2d9243fd163e1970ec9 100644
--- a/Img3D/Build/ParacrystalLatticePositions.h
+++ b/Img3D/Build/ParacrystalLatticePositions.h
@@ -15,14 +15,14 @@
 #ifndef BORNAGAIN_IMG3D_BUILD_PARACRYSTALLATTICEPOSITIONS_H
 #define BORNAGAIN_IMG3D_BUILD_PARACRYSTALLATTICEPOSITIONS_H
 
+#include "Base/Type/Field2D.h"
 #include <vector>
 
 class Interference2DParacrystal;
 
 namespace Paracrystal {
 
-std::vector<std::vector<double>> latticePositions(const Interference2DParacrystal*,
-                                                  double layer_size);
+double2d_t latticePositions(const Interference2DParacrystal*, double layer_size);
 }
 
 #endif // BORNAGAIN_IMG3D_BUILD_PARACRYSTALLATTICEPOSITIONS_H
diff --git a/Img3D/Build/PositionBuilders.cpp b/Img3D/Build/PositionBuilders.cpp
index dabbb1ca767723b211d991e42897b958043bf115..c2be21c9ac0321df7bb0b0b225bbdcbdb60928e1 100644
--- a/Img3D/Build/PositionBuilders.cpp
+++ b/Img3D/Build/PositionBuilders.cpp
@@ -19,10 +19,10 @@
 
 namespace {
 
-std::vector<std::vector<double>> Generate2DLatticePoints(double l1, double l2, double alpha,
-                                                         double xi, unsigned n1, unsigned n2)
+double2d_t Generate2DLatticePoints(double l1, double l2, double alpha, double xi, unsigned n1,
+                                   unsigned n2)
 {
-    std::vector<std::vector<double>> lattice_positions;
+    double2d_t lattice_positions;
     std::vector<double> position;
 
     const unsigned nn1 = std::max(1u, n1);
@@ -57,10 +57,9 @@ std::vector<std::vector<double>> Generate2DLatticePoints(double l1, double l2, d
 
 IPositionBuilder::~IPositionBuilder() = default;
 
-std::vector<std::vector<double>> IPositionBuilder::generatePositions(double layer_size,
-                                                                     double density) const
+double2d_t IPositionBuilder::generatePositions(double layer_size, double density) const
 {
-    std::vector<std::vector<double>> positions = generatePositionsImpl(layer_size, density);
+    double2d_t positions = generatePositionsImpl(layer_size, density);
     const double pos_var = positionVariance();
     if (pos_var > 0.0) {
         // random generator and distribution
@@ -84,10 +83,9 @@ RandomPositionBuilder::RandomPositionBuilder() = default;
 
 RandomPositionBuilder::~RandomPositionBuilder() = default;
 
-std::vector<std::vector<double>> RandomPositionBuilder::generatePositionsImpl(double layer_size,
-                                                                              double density) const
+double2d_t RandomPositionBuilder::generatePositionsImpl(double layer_size, double density) const
 {
-    std::vector<std::vector<double>> lattice_positions;
+    double2d_t lattice_positions;
     std::vector<double> position;
 
     // to compute total number of particles we use the total particle density
@@ -127,8 +125,7 @@ Lattice1DPositionBuilder::Lattice1DPositionBuilder(const Interference1DLattice*
 
 Lattice1DPositionBuilder::~Lattice1DPositionBuilder() = default;
 
-std::vector<std::vector<double>> Lattice1DPositionBuilder::generatePositionsImpl(double layer_size,
-                                                                                 double) const
+double2d_t Lattice1DPositionBuilder::generatePositionsImpl(double layer_size, double) const
 {
     const double length = m_iff->length();
     const double xi = m_iff->xi();
@@ -158,8 +155,7 @@ Lattice2DPositionBuilder::Lattice2DPositionBuilder(const Interference2DLattice*
 
 Lattice2DPositionBuilder::~Lattice2DPositionBuilder() = default;
 
-std::vector<std::vector<double>> Lattice2DPositionBuilder::generatePositionsImpl(double layer_size,
-                                                                                 double) const
+double2d_t Lattice2DPositionBuilder::generatePositionsImpl(double layer_size, double) const
 {
     const Lattice2D& lattice = m_iff->lattice();
     const double l1 = lattice.length1();
@@ -198,8 +194,7 @@ Paracrystal2DPositionBuilder::Paracrystal2DPositionBuilder(const Interference2DP
 
 Paracrystal2DPositionBuilder::~Paracrystal2DPositionBuilder() = default;
 
-std::vector<std::vector<double>>
-Paracrystal2DPositionBuilder::generatePositionsImpl(double layer_size, double) const
+double2d_t Paracrystal2DPositionBuilder::generatePositionsImpl(double layer_size, double) const
 {
     return Paracrystal::latticePositions(m_iff.get(), layer_size);
 }
@@ -222,8 +217,7 @@ Finite2DLatticePositionBuilder::Finite2DLatticePositionBuilder(
 
 Finite2DLatticePositionBuilder::~Finite2DLatticePositionBuilder() = default;
 
-std::vector<std::vector<double>>
-Finite2DLatticePositionBuilder::generatePositionsImpl(double layer_size, double) const
+double2d_t Finite2DLatticePositionBuilder::generatePositionsImpl(double layer_size, double) const
 {
     const auto& lattice = m_iff->lattice();
     const double l1 = lattice.length1();
@@ -264,10 +258,9 @@ RadialParacrystalPositionBuilder::RadialParacrystalPositionBuilder(
 
 RadialParacrystalPositionBuilder::~RadialParacrystalPositionBuilder() = default;
 
-std::vector<std::vector<double>>
-RadialParacrystalPositionBuilder::generatePositionsImpl(double layer_size, double) const
+double2d_t RadialParacrystalPositionBuilder::generatePositionsImpl(double layer_size, double) const
 {
-    std::vector<std::vector<double>> lattice_positions;
+    double2d_t lattice_positions;
 
     const double distance = m_iff->peakDistance();
 
diff --git a/Img3D/Build/PositionBuilders.h b/Img3D/Build/PositionBuilders.h
index 20d56bcaf848d0fed9a8de71fc996ba38a3cd931..6ae39c2ee5ec831e8843cc48e2164468b26385ab 100644
--- a/Img3D/Build/PositionBuilders.h
+++ b/Img3D/Build/PositionBuilders.h
@@ -15,6 +15,7 @@
 #ifndef BORNAGAIN_IMG3D_BUILD_POSITIONBUILDERS_H
 #define BORNAGAIN_IMG3D_BUILD_POSITIONBUILDERS_H
 
+#include "Base/Type/Field2D.h"
 #include <memory>
 #include <vector>
 
@@ -28,11 +29,10 @@ class IPositionBuilder {
 public:
     virtual ~IPositionBuilder();
 
-    std::vector<std::vector<double>> generatePositions(double layer_size, double density) const;
+    double2d_t generatePositions(double layer_size, double density) const;
 
 private:
-    virtual std::vector<std::vector<double>> generatePositionsImpl(double layer_size,
-                                                                   double density) const = 0;
+    virtual double2d_t generatePositionsImpl(double layer_size, double density) const = 0;
     virtual double positionVariance() const = 0;
 };
 
@@ -43,8 +43,7 @@ public:
     ~RandomPositionBuilder() override;
 
 private:
-    std::vector<std::vector<double>> generatePositionsImpl(double layer_size,
-                                                           double density) const override;
+    double2d_t generatePositionsImpl(double layer_size, double density) const override;
     double positionVariance() const override;
 };
 
@@ -55,8 +54,7 @@ public:
     ~Lattice1DPositionBuilder() override;
 
 private:
-    std::vector<std::vector<double>> generatePositionsImpl(double layer_size,
-                                                           double density) const override;
+    double2d_t generatePositionsImpl(double layer_size, double density) const override;
     double positionVariance() const override;
     std::unique_ptr<Interference1DLattice> m_iff;
 };
@@ -68,8 +66,7 @@ public:
     ~Lattice2DPositionBuilder() override;
 
 private:
-    std::vector<std::vector<double>> generatePositionsImpl(double layer_size,
-                                                           double density) const override;
+    double2d_t generatePositionsImpl(double layer_size, double density) const override;
     double positionVariance() const override;
     std::unique_ptr<Interference2DLattice> m_iff;
 };
@@ -81,8 +78,7 @@ public:
     ~Paracrystal2DPositionBuilder() override;
 
 private:
-    std::vector<std::vector<double>> generatePositionsImpl(double layer_size,
-                                                           double density) const override;
+    double2d_t generatePositionsImpl(double layer_size, double density) const override;
     double positionVariance() const override;
     std::unique_ptr<Interference2DParacrystal> m_iff;
 };
@@ -94,8 +90,7 @@ public:
     ~Finite2DLatticePositionBuilder() override;
 
 private:
-    std::vector<std::vector<double>> generatePositionsImpl(double layer_size,
-                                                           double density) const override;
+    double2d_t generatePositionsImpl(double layer_size, double density) const override;
     double positionVariance() const override;
     std::unique_ptr<InterferenceFinite2DLattice> m_iff;
 };
@@ -107,8 +102,7 @@ public:
     ~RadialParacrystalPositionBuilder() override;
 
 private:
-    std::vector<std::vector<double>> generatePositionsImpl(double layer_size,
-                                                           double density) const override;
+    double2d_t generatePositionsImpl(double layer_size, double density) const override;
     double positionVariance() const override;
     std::unique_ptr<InterferenceRadialParacrystal> m_iff;
 };
diff --git a/Img3D/Model/Geometry.h b/Img3D/Model/Geometry.h
index 4adf50aa1f0bbcaa9001967ee798de34145c5f43..0d0b4c7de84b8e4ef8464df7c52dd636e2631839 100644
--- a/Img3D/Model/Geometry.h
+++ b/Img3D/Model/Geometry.h
@@ -15,7 +15,7 @@
 #ifndef BORNAGAIN_IMG3D_MODEL_GEOMETRY_H
 #define BORNAGAIN_IMG3D_MODEL_GEOMETRY_H
 
-#include "Base/Type/Vector.h"
+#include "Base/Type/Field2D.h"
 #include "Img3D/Model/Geometry_inc.h"
 #include <QVector>
 
diff --git a/Img3D/Model/PlottableBody.h b/Img3D/Model/PlottableBody.h
index 69086a8c0167b66e62356dcc25d1cd114d59ebdd..5cd1faf44789fa433f1ff7177f42103aad220921 100644
--- a/Img3D/Model/PlottableBody.h
+++ b/Img3D/Model/PlottableBody.h
@@ -15,7 +15,7 @@
 #ifndef BORNAGAIN_IMG3D_MODEL_PLOTTABLEBODY_H
 #define BORNAGAIN_IMG3D_MODEL_PLOTTABLEBODY_H
 
-#include "Base/Type/Vector.h"
+#include "Base/Type/Field2D.h"
 #include "Img3D/Model/Geometry_inc.h"
 #include "Img3D/Type/FloatVector3D.h"
 #include <QColor>
diff --git a/Sample/Interface/RoughnessMap.cpp b/Sample/Interface/RoughnessMap.cpp
index ca7d483581fbf3a04e1858da274ab32bb8200969..ddad4ca77829c870df3a0999cc371fd811a1c4c3 100644
--- a/Sample/Interface/RoughnessMap.cpp
+++ b/Sample/Interface/RoughnessMap.cpp
@@ -14,7 +14,6 @@
 
 #include "Sample/Interface/RoughnessMap.h"
 #include "Base/Util/Assert.h"
-#include "Base/Util/Vec.h"
 #include <algorithm>
 #include <numbers>
 
@@ -77,18 +76,18 @@ double2d_t RoughnessMap::mapFromHeights() const
     const double step = 2 * z_limit / (z_steps - 1);
 
     // create mesh of values
-    double1d_t z_points(z_steps);
+    std::vector<double> z_points(z_steps);
     for (size_t i = 0; i < z_steps; i++)
         z_points[i] = -z_limit + step * i;
 
     // fill mesh with weights
-    double1d_t z_weights(z_steps);
+    std::vector<double> z_weights(z_steps);
     for (size_t i = 0; i < z_steps; i++)
         z_weights[i] = m_layerRoughness->roughnessModel()->distribution(z_points[i], sigma);
 
     // fill map with random values
     std::discrete_distribution<int> d(z_weights.begin(), z_weights.end());
-    double2d_t result(m_y_points, double1d_t(m_x_points));
+    double2d_t result(m_y_points, std::vector<double>(m_x_points));
     for (int j = 0; j < m_y_points; j++)
         for (int i = 0; i < m_x_points; i++)
             result[j][i] = z_points[d(m_gen)];
@@ -105,15 +104,15 @@ double2d_t RoughnessMap::mapFromSpectrum() const
     const int N = m_x_points / 2 + 1;
     const int M = m_y_points / 2 + 1;
 
-    double1d_t fx(N);
+    std::vector<double> fx(N);
     for (int i = 0; i < N; i++)
         fx[i] = 2 * pi * i * dfx;
 
-    double1d_t fy(M);
+    std::vector<double> fy(M);
     for (int j = 0; j < M; j++)
         fy[j] = 2 * pi * j * dfy;
 
-    double2d_t psd_mag(m_y_points, double1d_t(N));
+    double2d_t psd_mag(m_y_points, std::vector<double>(N));
     for (int i = 0; i < N; i++) {
         for (int j = 0; j < M; j++)
             psd_mag[j][i] = std::sqrt(m_layerRoughness->spectralFunction(R3(fx[i], fy[j], 0)));
@@ -123,7 +122,7 @@ double2d_t RoughnessMap::mapFromSpectrum() const
     psd_mag[0][0] = 0; // average height (amplitude at zero frequency) is null
 
     std::uniform_real_distribution<double> d(-pi, pi);
-    double2d_t phase(m_y_points, double1d_t(N));
+    double2d_t phase(m_y_points, std::vector<double>(N));
 
     // main axes
     // x axis
@@ -147,7 +146,7 @@ double2d_t RoughnessMap::mapFromSpectrum() const
                 phase[pos_j][pos_i] = +phase[sym_pos_j][pos_i];
         }
     }
-    complex2d_t spectrum(m_y_points, complex1d_t(N));
+    complex2d_t spectrum(m_y_points, std::vector<complex_t>(N));
     for (int j = 0; j < m_y_points; j++)
         for (int i = 0; i < N; i++)
             spectrum[j][i] = psd_mag[j][i] * std::exp(I * phase[j][i]) * fft_factor;
@@ -175,7 +174,7 @@ double2d_t RoughnessMap::applyHeightsToSpectrum(const double2d_t& h_map,
                                                 const double2d_t& s_map) const
 {
     // flatten spectral map
-    auto s_map_flat = Vec::flatten(s_map);
+    auto s_map_flat = FieldUtil::flatten(s_map);
 
     // sort and remember the original positions
     std::vector<std::pair<double, size_t>> s_map_indexed(s_map_flat.size());
@@ -185,19 +184,19 @@ double2d_t RoughnessMap::applyHeightsToSpectrum(const double2d_t& h_map,
     std::sort(s_map_indexed.begin(), s_map_indexed.end());
 
     // replace heights of spectral map
-    auto h_map_flat = Vec::flatten(h_map);
+    auto h_map_flat = FieldUtil::flatten(h_map);
     std::sort(h_map_flat.begin(), h_map_flat.end());
 
     for (size_t i = 0; i < s_map_flat.size(); i++)
         s_map_flat[s_map_indexed[i].second] = h_map_flat[i];
 
-    return Vec::reshapeTo2D(s_map_flat, s_map.size());
+    return FieldUtil::reshapeTo2D(s_map_flat, s_map.size());
 }
 
 void RoughnessMap::createMap()
 {
     if (m_layerRoughness->sigma() < 1e-10) {
-        m_rough_map = double2d_t(m_y_points, double1d_t(m_x_points));
+        m_rough_map = double2d_t(m_y_points, std::vector<double>(m_x_points));
         return;
     }
 
@@ -229,7 +228,7 @@ PyObject* RoughnessMap::generate()
 {
     createMap();
     std::vector<std::size_t> dimensions = {m_rough_map.size(), m_rough_map[0].size()};
-    return PyInterpreter::Numpy::fromCppVector(dimensions, Vec::flatten(m_rough_map));
+    return PyInterpreter::Numpy::fromCppVector(dimensions, FieldUtil::flatten(m_rough_map));
 }
 
 #endif // BORNAGAIN_PYTHON
diff --git a/Tests/Unit/Device/DatafieldTest.cpp b/Tests/Unit/Device/DatafieldTest.cpp
index 86c7e112a799e4101c477dd8d103215d581f1523..87c1c0e02845886ea0c94779b8dd5924c50dfcf8 100644
--- a/Tests/Unit/Device/DatafieldTest.cpp
+++ b/Tests/Unit/Device/DatafieldTest.cpp
@@ -70,14 +70,14 @@ TEST(Datafield, create2DArrayfromDatafield)
 
     auto v3 = a.values2D();
 
-    std::vector<std::vector<double>> v3expected{{0, 1, 2}, {3, 4, 5}};
+    double2d_t v3expected{{0, 1, 2}, {3, 4, 5}};
     EXPECT_EQ(v3, v3expected);
 }
 
 TEST(Datafield, ctor2D)
 {
     std::vector<double> arr_in{1, 2, 3, 4, 5, 6};
-    std::vector<std::vector<double>> array_2d{{1., 2., 3.}, {4., 5., 6.}};
+    double2d_t array_2d{{1., 2., 3.}, {4., 5., 6.}};
     const Datafield data("x ()", "y ()", array_2d);
     EXPECT_EQ(arr_in, data.flatVector());
 }
@@ -90,6 +90,6 @@ TEST(Datafield, DatafieldToVector2D)
     data.setVector(values);
 
     auto vec = data.values2D();
-    const std::vector<std::vector<double>> expected = {{0., 1., 2.}, {10., 11., 12.}};
+    const double2d_t expected = {{0., 1., 2.}, {10., 11., 12.}};
     EXPECT_EQ(vec, expected);
 }
diff --git a/Tests/Unit/Device/SpectrumTest.cpp b/Tests/Unit/Device/SpectrumTest.cpp
index 7324620c290beca414b8dd974058886e9a455f28..a916324366c7d620ecf641a61721b0973eadd3db 100644
--- a/Tests/Unit/Device/SpectrumTest.cpp
+++ b/Tests/Unit/Device/SpectrumTest.cpp
@@ -6,12 +6,12 @@
 
 TEST(Spectrum, arrayPeaks)
 {
-    std::vector<std::vector<double>> data = {{1.0, 1.0, 1.0, 1.0, 1.0, 1.0, 1.0, 1.0, 1.0, 1.0},
-                                             {1.0, 1.0, 1.0, 1.0, 1.0, 1.0, 1.0, 1.0, 1.0, 1.0},
-                                             {1.0, 1.0, 1.0, 1.0, 1.0, 1.0, 1.0, 1.0, 1.0, 1.0},
-                                             {1.0, 1.0, 1.0, 1.0, 10.0, 1.0, 1.0, 1.0, 1.0, 1.0},
-                                             {1.0, 1.0, 1.0, 1.0, 1.0, 1.0, 1.0, 1.0, 1.0, 1.0},
-                                             {1.0, 1.0, 1.0, 1.0, 1.0, 1.0, 1.0, 1.0, 1.0, 1.0}};
+    double2d_t data = {{1.0, 1.0, 1.0, 1.0, 1.0, 1.0, 1.0, 1.0, 1.0, 1.0},
+                       {1.0, 1.0, 1.0, 1.0, 1.0, 1.0, 1.0, 1.0, 1.0, 1.0},
+                       {1.0, 1.0, 1.0, 1.0, 1.0, 1.0, 1.0, 1.0, 1.0, 1.0},
+                       {1.0, 1.0, 1.0, 1.0, 10.0, 1.0, 1.0, 1.0, 1.0, 1.0},
+                       {1.0, 1.0, 1.0, 1.0, 1.0, 1.0, 1.0, 1.0, 1.0, 1.0},
+                       {1.0, 1.0, 1.0, 1.0, 1.0, 1.0, 1.0, 1.0, 1.0, 1.0}};
 
     tspectrum::Spectrum2D finder;
     auto peaks = finder.find_peaks(data, 3, "nomarkov", 0.1);
diff --git a/Tests/Unit/Numeric/FourierTransformTest.cpp b/Tests/Unit/Numeric/FourierTransformTest.cpp
index f12544f52266b5528f0a6cb7dfc092d34e611463..abfecc54adaa653aebb19d7cefcfcf9849b8cb8d 100644
--- a/Tests/Unit/Numeric/FourierTransformTest.cpp
+++ b/Tests/Unit/Numeric/FourierTransformTest.cpp
@@ -87,12 +87,11 @@ TEST(FourierTransform, fft1D)
 // 3x5 input of all zeros
 TEST(FourierTransform, fft2DTest1)
 {
-    std::vector<std::vector<double>> signal({{0, 0, 0, 0, 0}, {0, 0, 0, 0, 0}, {0, 0, 0, 0, 0}});
-    std::vector<std::vector<double>> expected_result(
-        {{0, 0, 0, 0, 0}, {0, 0, 0, 0, 0}, {0, 0, 0, 0, 0}});
+    double2d_t signal({{0, 0, 0, 0, 0}, {0, 0, 0, 0, 0}, {0, 0, 0, 0, 0}});
+    double2d_t expected_result({{0, 0, 0, 0, 0}, {0, 0, 0, 0, 0}, {0, 0, 0, 0, 0}});
 
     FourierTransform ft;
-    std::vector<std::vector<double>> result = ft.ramplitude(signal);
+    double2d_t result = ft.ramplitude(signal);
     result = ft.fftshift(result);
 
     for (size_t i = 0; i < signal.size(); ++i)
@@ -103,13 +102,12 @@ TEST(FourierTransform, fft2DTest1)
 // 4x5 input of all zeros except for 1 element
 TEST(FourierTransform, fft2DTest2)
 {
-    std::vector<std::vector<double>> signal(
-        {{0, 0, 0, 0, 0}, {0, 0, 2, 0, 0}, {0, 0, 0, 0, 0}, {0, 0, 0, 0, 0}});
-    std::vector<std::vector<double>> expected_result(
+    double2d_t signal({{0, 0, 0, 0, 0}, {0, 0, 2, 0, 0}, {0, 0, 0, 0, 0}, {0, 0, 0, 0, 0}});
+    double2d_t expected_result(
         {{2, 2, 2, 2, 2}, {2, 2, 2, 2, 2}, {2, 2, 2, 2, 2}, {2, 2, 2, 2, 2}});
 
     FourierTransform ft;
-    std::vector<std::vector<double>> result = ft.ramplitude(signal);
+    double2d_t result = ft.ramplitude(signal);
     result = ft.fftshift(result);
 
     for (size_t i = 0; i < signal.size(); ++i)
@@ -120,21 +118,21 @@ TEST(FourierTransform, fft2DTest2)
 // 6x6 input of all ones except for 1 element
 TEST(FourierTransform, fft2DTest3)
 {
-    std::vector<std::vector<double>> signal({{1, 1, 1, 1, 1, 1},
-                                             {1, 1, 1, 1, 1, 1},
-                                             {1, 1, 1, 1, 1, 1},
-                                             {1, 1, 1, 1, 1, 1},
-                                             {1, 1, 1, 1, 1, 32},
-                                             {1, 1, 1, 1, 1, 1}});
-    std::vector<std::vector<double>> expected_result({{31, 31, 31, 31, 31, 31},
-                                                      {31, 31, 31, 31, 31, 31},
-                                                      {31, 31, 31, 31, 31, 31},
-                                                      {31, 31, 31, 67, 31, 31},
-                                                      {31, 31, 31, 31, 31, 31},
-                                                      {31, 31, 31, 31, 31, 31}});
+    double2d_t signal({{1, 1, 1, 1, 1, 1},
+                       {1, 1, 1, 1, 1, 1},
+                       {1, 1, 1, 1, 1, 1},
+                       {1, 1, 1, 1, 1, 1},
+                       {1, 1, 1, 1, 1, 32},
+                       {1, 1, 1, 1, 1, 1}});
+    double2d_t expected_result({{31, 31, 31, 31, 31, 31},
+                                {31, 31, 31, 31, 31, 31},
+                                {31, 31, 31, 31, 31, 31},
+                                {31, 31, 31, 67, 31, 31},
+                                {31, 31, 31, 31, 31, 31},
+                                {31, 31, 31, 31, 31, 31}});
 
     FourierTransform ft;
-    std::vector<std::vector<double>> result = ft.ramplitude(signal);
+    double2d_t result = ft.ramplitude(signal);
     result = ft.fftshift(result);
 
     for (size_t i = 0; i < signal.size(); ++i)
@@ -145,24 +143,24 @@ TEST(FourierTransform, fft2DTest3)
 // 3x5 input with 1 row of all zeros
 TEST(FourierTransform, fft2DTest4)
 {
-    std::vector<std::vector<double>> signal({{1, 88, 0, 1, 0}, {0, 1, 1, 1, 0}, {0, 0, 0, 0, 0}});
+    double2d_t signal({{1, 88, 0, 1, 0}, {0, 1, 1, 1, 0}, {0, 0, 0, 0, 0}});
 
     FourierTransform ft;
 
     // shift
-    std::vector<std::vector<double>> signal_shifted = ft.fftshift(signal);
+    double2d_t signal_shifted = ft.fftshift(signal);
     signal_shifted = ft.ifftshift(signal_shifted);
     for (size_t i = 0; i < signal.size(); ++i)
         for (size_t j = 0; j < signal[0].size(); ++j)
             EXPECT_NEAR(signal_shifted[i][j], signal[i][j], 1e-13);
 
     // amplitude, shifted
-    std::vector<std::vector<double>> expected_result_amp(
+    double2d_t expected_result_amp(
         {{87.56947917, 85.92017286, 88.53812738, 88.59651195, 86.95382846},
          {88.02055461, 88.00785173, 93., 88.00785173, 88.02055461},
          {86.95382846, 88.59651195, 88.53812738, 85.92017286, 87.56947917}});
 
-    std::vector<std::vector<double>> result_amp = ft.ramplitude(signal);
+    double2d_t result_amp = ft.ramplitude(signal);
     result_amp = ft.fftshift(result_amp);
 
     for (size_t i = 0; i < signal.size(); ++i)
@@ -183,7 +181,7 @@ TEST(FourierTransform, fft2DTest4)
             EXPECT_NEAR(abs(result[i][j] - expected_result[i][j]), 0, abs(result[i][j]) * 1e-8);
 
     // inverse
-    std::vector<std::vector<double>> result_inv = ft.irfft(result, signal[0].size());
+    double2d_t result_inv = ft.irfft(result, signal[0].size());
 
     EXPECT_EQ(signal[0].size(), result_inv[0].size());
     for (size_t i = 0; i < signal.size(); ++i)
@@ -194,26 +192,24 @@ TEST(FourierTransform, fft2DTest4)
 // 4x4 input
 TEST(FourierTransform, fft2DTest5)
 {
-    std::vector<std::vector<double>> signal(
-        {{1, 0, 0, 5}, {1, 0, 0, 0}, {0, 1, 1, 1}, {0, 1, 1, 1}});
+    double2d_t signal({{1, 0, 0, 5}, {1, 0, 0, 0}, {0, 1, 1, 1}, {0, 1, 1, 1}});
 
     FourierTransform ft;
 
     // shift
-    std::vector<std::vector<double>> signal_shifted = ft.fftshift(signal);
+    double2d_t signal_shifted = ft.fftshift(signal);
     signal_shifted = ft.ifftshift(signal_shifted);
     for (size_t i = 0; i < signal.size(); ++i)
         for (size_t j = 0; j < signal[0].size(); ++j)
             EXPECT_NEAR(signal_shifted[i][j], signal[i][j], 1e-13);
 
     // amplitude, shifted
-    std::vector<std::vector<double>> expected_result_amp(
-        {{5., 5., 5., 5.},
-         {3.60555128, 3.60555128, 3.60555128, 7.28010989},
-         {5., 5., 13., 5.},
-         {3.60555128, 7.28010989, 3.60555128, 3.60555128}});
+    double2d_t expected_result_amp({{5., 5., 5., 5.},
+                                    {3.60555128, 3.60555128, 3.60555128, 7.28010989},
+                                    {5., 5., 13., 5.},
+                                    {3.60555128, 7.28010989, 3.60555128, 3.60555128}});
 
-    std::vector<std::vector<double>> result_amp = ft.ramplitude(signal);
+    double2d_t result_amp = ft.ramplitude(signal);
     result_amp = ft.fftshift(result_amp);
 
     for (size_t i = 0; i < signal.size(); ++i)
@@ -234,7 +230,7 @@ TEST(FourierTransform, fft2DTest5)
             EXPECT_NEAR(abs(result[i][j] - expected_result[i][j]), 0, abs(result[i][j]) * 1e-8);
 
     // inverse
-    std::vector<std::vector<double>> result_inv = ft.irfft(result, signal[0].size());
+    double2d_t result_inv = ft.irfft(result, signal[0].size());
 
     EXPECT_EQ(signal[0].size(), result_inv[0].size());
     for (size_t i = 0; i < signal.size(); ++i)
@@ -245,12 +241,12 @@ TEST(FourierTransform, fft2DTest5)
 // 7x7 input
 TEST(FourierTransform, fft2DTest6)
 {
-    std::vector<std::vector<double>> signal{
-        {1., 0., 0., 0., 0., 0., 0.}, {1., 0., 0., 0., 0., 0., 0.}, {1., 0., 5., 0., 0., 0., 0.},
-        {1., 0., 0., 0., 0., 0., 0.}, {1., 0., 0., 0., 0., 5., 0.}, {1., 0., 0., 0., 0., 0., 0.},
-        {1., 0., 0., 0., 0., 0., 0.}};
+    double2d_t signal{{1., 0., 0., 0., 0., 0., 0.}, {1., 0., 0., 0., 0., 0., 0.},
+                      {1., 0., 5., 0., 0., 0., 0.}, {1., 0., 0., 0., 0., 0., 0.},
+                      {1., 0., 0., 0., 0., 5., 0.}, {1., 0., 0., 0., 0., 0., 0.},
+                      {1., 0., 0., 0., 0., 0., 0.}};
 
-    std::vector<std::vector<double>> expected_result(
+    double2d_t expected_result(
         {{9.00968868, 6.23489802, 6.23489802, 9.00968868, 2.22520934, 10., 2.22520934},
          {9.00968868, 2.22520934, 10., 2.22520934, 9.00968868, 6.23489802, 6.23489802},
          {2.22520934, 9.00968868, 6.23489802, 6.23489802, 9.00968868, 2.22520934, 10.},
@@ -260,7 +256,7 @@ TEST(FourierTransform, fft2DTest6)
          {2.22520934, 10., 2.22520934, 9.00968868, 6.23489802, 6.23489802, 9.00968868}});
 
     FourierTransform ft;
-    std::vector<std::vector<double>> result = ft.ramplitude(signal);
+    double2d_t result = ft.ramplitude(signal);
     result = ft.fftshift(result);
 
     for (size_t i = 0; i < signal.size(); ++i)
diff --git a/Wrap/Swig/commons.i b/Wrap/Swig/commons.i
index deea3b45d8234fdd9657a561f3790d2556aa9884..ca248490e44e89909b7069cecfe797cb1e6ecb3f 100644
--- a/Wrap/Swig/commons.i
+++ b/Wrap/Swig/commons.i
@@ -34,16 +34,16 @@
 #define BORNAGAIN_PYTHON
 #endif
 
-%template(vdouble1d_t) std::vector<double>;
-%template(vdouble2d_t) std::vector<std::vector<double>>;
-%template(vector_integer_t) std::vector<int>;
-%template(vinteger2d_t) std::vector<std::vector<int>>;
-%template(vector_longinteger_t) std::vector<unsigned long int>;
-%template(vector_complex_t) std::vector< std::complex<double>>;
-%template(vector_string_t) std::vector<std::string>;
-%template(map_string_double_t) std::map<std::string, double>;
-%template(pvacuum_double_t) std::pair<double, double>;
-%template(vector_pvacuum_double_t) std::vector<std::pair<double, double>>;
+%template(vdouble1d_T) std::vector<double>;
+%template(vdouble2d_T) std::vector<std::vector<double>>;
+%template(vector_integer_T) std::vector<int>;
+%template(vinteger2d_T) std::vector<std::vector<int>>;
+%template(vector_longinteger_T) std::vector<unsigned long int>;
+%template(vector_complex_T) std::vector< std::complex<double>>;
+%template(vector_string_T) std::vector<std::string>;
+%template(map_string_double_T) std::map<std::string, double>;
+%template(pvacuum_double_T) std::pair<double, double>;
+%template(vector_pvacuum_double_T) std::vector<std::pair<double, double>>;
 
 // Automatic exception handling: Convert C++ exceptions to Python exceptions;
 // see <https://www.swig.org/Doc4.1/Library.html#Library_stl_exceptions>
diff --git a/auto/Wrap/libBornAgainBase.py b/auto/Wrap/libBornAgainBase.py
index 975cf6dd1f25b0a2a95d1459e0601522b4d07a64..72a73617ece4a85eaeb9ed78f7c56487f1d78d3f 100644
--- a/auto/Wrap/libBornAgainBase.py
+++ b/auto/Wrap/libBornAgainBase.py
@@ -153,1191 +153,1191 @@ def deprecated(message):
       return deprecated_func
   return deprecated_decorator
 
-class vdouble1d_t(object):
+class vdouble1d_T(object):
     r"""Proxy of C++ std::vector< double > class."""
 
     thisown = property(lambda x: x.this.own(), lambda x, v: x.this.own(v), doc="The membership flag")
     __repr__ = _swig_repr
 
     def iterator(self):
-        r"""iterator(vdouble1d_t self) -> SwigPyIterator"""
-        return _libBornAgainBase.vdouble1d_t_iterator(self)
+        r"""iterator(vdouble1d_T self) -> SwigPyIterator"""
+        return _libBornAgainBase.vdouble1d_T_iterator(self)
     def __iter__(self):
         return self.iterator()
 
     def __nonzero__(self):
-        r"""__nonzero__(vdouble1d_t self) -> bool"""
-        return _libBornAgainBase.vdouble1d_t___nonzero__(self)
+        r"""__nonzero__(vdouble1d_T self) -> bool"""
+        return _libBornAgainBase.vdouble1d_T___nonzero__(self)
 
     def __bool__(self):
-        r"""__bool__(vdouble1d_t self) -> bool"""
-        return _libBornAgainBase.vdouble1d_t___bool__(self)
+        r"""__bool__(vdouble1d_T self) -> bool"""
+        return _libBornAgainBase.vdouble1d_T___bool__(self)
 
     def __len__(self):
-        r"""__len__(vdouble1d_t self) -> std::vector< double >::size_type"""
-        return _libBornAgainBase.vdouble1d_t___len__(self)
+        r"""__len__(vdouble1d_T self) -> std::vector< double >::size_type"""
+        return _libBornAgainBase.vdouble1d_T___len__(self)
 
     def __getslice__(self, i, j):
-        r"""__getslice__(vdouble1d_t self, std::vector< double >::difference_type i, std::vector< double >::difference_type j) -> vdouble1d_t"""
-        return _libBornAgainBase.vdouble1d_t___getslice__(self, i, j)
+        r"""__getslice__(vdouble1d_T self, std::vector< double >::difference_type i, std::vector< double >::difference_type j) -> vdouble1d_T"""
+        return _libBornAgainBase.vdouble1d_T___getslice__(self, i, j)
 
     def __setslice__(self, *args):
         r"""
-        __setslice__(vdouble1d_t self, std::vector< double >::difference_type i, std::vector< double >::difference_type j)
-        __setslice__(vdouble1d_t self, std::vector< double >::difference_type i, std::vector< double >::difference_type j, vdouble1d_t v)
+        __setslice__(vdouble1d_T self, std::vector< double >::difference_type i, std::vector< double >::difference_type j)
+        __setslice__(vdouble1d_T self, std::vector< double >::difference_type i, std::vector< double >::difference_type j, vdouble1d_T v)
         """
-        return _libBornAgainBase.vdouble1d_t___setslice__(self, *args)
+        return _libBornAgainBase.vdouble1d_T___setslice__(self, *args)
 
     def __delslice__(self, i, j):
-        r"""__delslice__(vdouble1d_t self, std::vector< double >::difference_type i, std::vector< double >::difference_type j)"""
-        return _libBornAgainBase.vdouble1d_t___delslice__(self, i, j)
+        r"""__delslice__(vdouble1d_T self, std::vector< double >::difference_type i, std::vector< double >::difference_type j)"""
+        return _libBornAgainBase.vdouble1d_T___delslice__(self, i, j)
 
     def __delitem__(self, *args):
         r"""
-        __delitem__(vdouble1d_t self, std::vector< double >::difference_type i)
-        __delitem__(vdouble1d_t self, SWIGPY_SLICEOBJECT * slice)
+        __delitem__(vdouble1d_T self, std::vector< double >::difference_type i)
+        __delitem__(vdouble1d_T self, SWIGPY_SLICEOBJECT * slice)
         """
-        return _libBornAgainBase.vdouble1d_t___delitem__(self, *args)
+        return _libBornAgainBase.vdouble1d_T___delitem__(self, *args)
 
     def __getitem__(self, *args):
         r"""
-        __getitem__(vdouble1d_t self, SWIGPY_SLICEOBJECT * slice) -> vdouble1d_t
-        __getitem__(vdouble1d_t self, std::vector< double >::difference_type i) -> std::vector< double >::value_type const &
+        __getitem__(vdouble1d_T self, SWIGPY_SLICEOBJECT * slice) -> vdouble1d_T
+        __getitem__(vdouble1d_T self, std::vector< double >::difference_type i) -> std::vector< double >::value_type const &
         """
-        return _libBornAgainBase.vdouble1d_t___getitem__(self, *args)
+        return _libBornAgainBase.vdouble1d_T___getitem__(self, *args)
 
     def __setitem__(self, *args):
         r"""
-        __setitem__(vdouble1d_t self, SWIGPY_SLICEOBJECT * slice, vdouble1d_t v)
-        __setitem__(vdouble1d_t self, SWIGPY_SLICEOBJECT * slice)
-        __setitem__(vdouble1d_t self, std::vector< double >::difference_type i, std::vector< double >::value_type const & x)
+        __setitem__(vdouble1d_T self, SWIGPY_SLICEOBJECT * slice, vdouble1d_T v)
+        __setitem__(vdouble1d_T self, SWIGPY_SLICEOBJECT * slice)
+        __setitem__(vdouble1d_T self, std::vector< double >::difference_type i, std::vector< double >::value_type const & x)
         """
-        return _libBornAgainBase.vdouble1d_t___setitem__(self, *args)
+        return _libBornAgainBase.vdouble1d_T___setitem__(self, *args)
 
     def pop(self):
-        r"""pop(vdouble1d_t self) -> std::vector< double >::value_type"""
-        return _libBornAgainBase.vdouble1d_t_pop(self)
+        r"""pop(vdouble1d_T self) -> std::vector< double >::value_type"""
+        return _libBornAgainBase.vdouble1d_T_pop(self)
 
     def append(self, x):
-        r"""append(vdouble1d_t self, std::vector< double >::value_type const & x)"""
-        return _libBornAgainBase.vdouble1d_t_append(self, x)
+        r"""append(vdouble1d_T self, std::vector< double >::value_type const & x)"""
+        return _libBornAgainBase.vdouble1d_T_append(self, x)
 
     def empty(self):
-        r"""empty(vdouble1d_t self) -> bool"""
-        return _libBornAgainBase.vdouble1d_t_empty(self)
+        r"""empty(vdouble1d_T self) -> bool"""
+        return _libBornAgainBase.vdouble1d_T_empty(self)
 
     def size(self):
-        r"""size(vdouble1d_t self) -> std::vector< double >::size_type"""
-        return _libBornAgainBase.vdouble1d_t_size(self)
+        r"""size(vdouble1d_T self) -> std::vector< double >::size_type"""
+        return _libBornAgainBase.vdouble1d_T_size(self)
 
     def swap(self, v):
-        r"""swap(vdouble1d_t self, vdouble1d_t v)"""
-        return _libBornAgainBase.vdouble1d_t_swap(self, v)
+        r"""swap(vdouble1d_T self, vdouble1d_T v)"""
+        return _libBornAgainBase.vdouble1d_T_swap(self, v)
 
     def begin(self):
-        r"""begin(vdouble1d_t self) -> std::vector< double >::iterator"""
-        return _libBornAgainBase.vdouble1d_t_begin(self)
+        r"""begin(vdouble1d_T self) -> std::vector< double >::iterator"""
+        return _libBornAgainBase.vdouble1d_T_begin(self)
 
     def end(self):
-        r"""end(vdouble1d_t self) -> std::vector< double >::iterator"""
-        return _libBornAgainBase.vdouble1d_t_end(self)
+        r"""end(vdouble1d_T self) -> std::vector< double >::iterator"""
+        return _libBornAgainBase.vdouble1d_T_end(self)
 
     def rbegin(self):
-        r"""rbegin(vdouble1d_t self) -> std::vector< double >::reverse_iterator"""
-        return _libBornAgainBase.vdouble1d_t_rbegin(self)
+        r"""rbegin(vdouble1d_T self) -> std::vector< double >::reverse_iterator"""
+        return _libBornAgainBase.vdouble1d_T_rbegin(self)
 
     def rend(self):
-        r"""rend(vdouble1d_t self) -> std::vector< double >::reverse_iterator"""
-        return _libBornAgainBase.vdouble1d_t_rend(self)
+        r"""rend(vdouble1d_T self) -> std::vector< double >::reverse_iterator"""
+        return _libBornAgainBase.vdouble1d_T_rend(self)
 
     def clear(self):
-        r"""clear(vdouble1d_t self)"""
-        return _libBornAgainBase.vdouble1d_t_clear(self)
+        r"""clear(vdouble1d_T self)"""
+        return _libBornAgainBase.vdouble1d_T_clear(self)
 
     def get_allocator(self):
-        r"""get_allocator(vdouble1d_t self) -> std::vector< double >::allocator_type"""
-        return _libBornAgainBase.vdouble1d_t_get_allocator(self)
+        r"""get_allocator(vdouble1d_T self) -> std::vector< double >::allocator_type"""
+        return _libBornAgainBase.vdouble1d_T_get_allocator(self)
 
     def pop_back(self):
-        r"""pop_back(vdouble1d_t self)"""
-        return _libBornAgainBase.vdouble1d_t_pop_back(self)
+        r"""pop_back(vdouble1d_T self)"""
+        return _libBornAgainBase.vdouble1d_T_pop_back(self)
 
     def erase(self, *args):
         r"""
-        erase(vdouble1d_t self, std::vector< double >::iterator pos) -> std::vector< double >::iterator
-        erase(vdouble1d_t self, std::vector< double >::iterator first, std::vector< double >::iterator last) -> std::vector< double >::iterator
+        erase(vdouble1d_T self, std::vector< double >::iterator pos) -> std::vector< double >::iterator
+        erase(vdouble1d_T self, std::vector< double >::iterator first, std::vector< double >::iterator last) -> std::vector< double >::iterator
         """
-        return _libBornAgainBase.vdouble1d_t_erase(self, *args)
+        return _libBornAgainBase.vdouble1d_T_erase(self, *args)
 
     def __init__(self, *args):
         r"""
-        __init__(vdouble1d_t self) -> vdouble1d_t
-        __init__(vdouble1d_t self, vdouble1d_t other) -> vdouble1d_t
-        __init__(vdouble1d_t self, std::vector< double >::size_type size) -> vdouble1d_t
-        __init__(vdouble1d_t self, std::vector< double >::size_type size, std::vector< double >::value_type const & value) -> vdouble1d_t
+        __init__(vdouble1d_T self) -> vdouble1d_T
+        __init__(vdouble1d_T self, vdouble1d_T other) -> vdouble1d_T
+        __init__(vdouble1d_T self, std::vector< double >::size_type size) -> vdouble1d_T
+        __init__(vdouble1d_T self, std::vector< double >::size_type size, std::vector< double >::value_type const & value) -> vdouble1d_T
         """
-        _libBornAgainBase.vdouble1d_t_swiginit(self, _libBornAgainBase.new_vdouble1d_t(*args))
+        _libBornAgainBase.vdouble1d_T_swiginit(self, _libBornAgainBase.new_vdouble1d_T(*args))
 
     def push_back(self, x):
-        r"""push_back(vdouble1d_t self, std::vector< double >::value_type const & x)"""
-        return _libBornAgainBase.vdouble1d_t_push_back(self, x)
+        r"""push_back(vdouble1d_T self, std::vector< double >::value_type const & x)"""
+        return _libBornAgainBase.vdouble1d_T_push_back(self, x)
 
     def front(self):
-        r"""front(vdouble1d_t self) -> std::vector< double >::value_type const &"""
-        return _libBornAgainBase.vdouble1d_t_front(self)
+        r"""front(vdouble1d_T self) -> std::vector< double >::value_type const &"""
+        return _libBornAgainBase.vdouble1d_T_front(self)
 
     def back(self):
-        r"""back(vdouble1d_t self) -> std::vector< double >::value_type const &"""
-        return _libBornAgainBase.vdouble1d_t_back(self)
+        r"""back(vdouble1d_T self) -> std::vector< double >::value_type const &"""
+        return _libBornAgainBase.vdouble1d_T_back(self)
 
     def assign(self, n, x):
-        r"""assign(vdouble1d_t self, std::vector< double >::size_type n, std::vector< double >::value_type const & x)"""
-        return _libBornAgainBase.vdouble1d_t_assign(self, n, x)
+        r"""assign(vdouble1d_T self, std::vector< double >::size_type n, std::vector< double >::value_type const & x)"""
+        return _libBornAgainBase.vdouble1d_T_assign(self, n, x)
 
     def resize(self, *args):
         r"""
-        resize(vdouble1d_t self, std::vector< double >::size_type new_size)
-        resize(vdouble1d_t self, std::vector< double >::size_type new_size, std::vector< double >::value_type const & x)
+        resize(vdouble1d_T self, std::vector< double >::size_type new_size)
+        resize(vdouble1d_T self, std::vector< double >::size_type new_size, std::vector< double >::value_type const & x)
         """
-        return _libBornAgainBase.vdouble1d_t_resize(self, *args)
+        return _libBornAgainBase.vdouble1d_T_resize(self, *args)
 
     def insert(self, *args):
         r"""
-        insert(vdouble1d_t self, std::vector< double >::iterator pos, std::vector< double >::value_type const & x) -> std::vector< double >::iterator
-        insert(vdouble1d_t self, std::vector< double >::iterator pos, std::vector< double >::size_type n, std::vector< double >::value_type const & x)
+        insert(vdouble1d_T self, std::vector< double >::iterator pos, std::vector< double >::value_type const & x) -> std::vector< double >::iterator
+        insert(vdouble1d_T self, std::vector< double >::iterator pos, std::vector< double >::size_type n, std::vector< double >::value_type const & x)
         """
-        return _libBornAgainBase.vdouble1d_t_insert(self, *args)
+        return _libBornAgainBase.vdouble1d_T_insert(self, *args)
 
     def reserve(self, n):
-        r"""reserve(vdouble1d_t self, std::vector< double >::size_type n)"""
-        return _libBornAgainBase.vdouble1d_t_reserve(self, n)
+        r"""reserve(vdouble1d_T self, std::vector< double >::size_type n)"""
+        return _libBornAgainBase.vdouble1d_T_reserve(self, n)
 
     def capacity(self):
-        r"""capacity(vdouble1d_t self) -> std::vector< double >::size_type"""
-        return _libBornAgainBase.vdouble1d_t_capacity(self)
-    __swig_destroy__ = _libBornAgainBase.delete_vdouble1d_t
+        r"""capacity(vdouble1d_T self) -> std::vector< double >::size_type"""
+        return _libBornAgainBase.vdouble1d_T_capacity(self)
+    __swig_destroy__ = _libBornAgainBase.delete_vdouble1d_T
 
-# Register vdouble1d_t in _libBornAgainBase:
-_libBornAgainBase.vdouble1d_t_swigregister(vdouble1d_t)
-class vdouble2d_t(object):
+# Register vdouble1d_T in _libBornAgainBase:
+_libBornAgainBase.vdouble1d_T_swigregister(vdouble1d_T)
+class vdouble2d_T(object):
     r"""Proxy of C++ std::vector< std::vector< double > > class."""
 
     thisown = property(lambda x: x.this.own(), lambda x, v: x.this.own(v), doc="The membership flag")
     __repr__ = _swig_repr
 
     def iterator(self):
-        r"""iterator(vdouble2d_t self) -> SwigPyIterator"""
-        return _libBornAgainBase.vdouble2d_t_iterator(self)
+        r"""iterator(vdouble2d_T self) -> SwigPyIterator"""
+        return _libBornAgainBase.vdouble2d_T_iterator(self)
     def __iter__(self):
         return self.iterator()
 
     def __nonzero__(self):
-        r"""__nonzero__(vdouble2d_t self) -> bool"""
-        return _libBornAgainBase.vdouble2d_t___nonzero__(self)
+        r"""__nonzero__(vdouble2d_T self) -> bool"""
+        return _libBornAgainBase.vdouble2d_T___nonzero__(self)
 
     def __bool__(self):
-        r"""__bool__(vdouble2d_t self) -> bool"""
-        return _libBornAgainBase.vdouble2d_t___bool__(self)
+        r"""__bool__(vdouble2d_T self) -> bool"""
+        return _libBornAgainBase.vdouble2d_T___bool__(self)
 
     def __len__(self):
-        r"""__len__(vdouble2d_t self) -> std::vector< std::vector< double > >::size_type"""
-        return _libBornAgainBase.vdouble2d_t___len__(self)
+        r"""__len__(vdouble2d_T self) -> std::vector< std::vector< double > >::size_type"""
+        return _libBornAgainBase.vdouble2d_T___len__(self)
 
     def __getslice__(self, i, j):
-        r"""__getslice__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j) -> vdouble2d_t"""
-        return _libBornAgainBase.vdouble2d_t___getslice__(self, i, j)
+        r"""__getslice__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j) -> vdouble2d_T"""
+        return _libBornAgainBase.vdouble2d_T___getslice__(self, i, j)
 
     def __setslice__(self, *args):
         r"""
-        __setslice__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j)
-        __setslice__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j, vdouble2d_t v)
+        __setslice__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j)
+        __setslice__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j, vdouble2d_T v)
         """
-        return _libBornAgainBase.vdouble2d_t___setslice__(self, *args)
+        return _libBornAgainBase.vdouble2d_T___setslice__(self, *args)
 
     def __delslice__(self, i, j):
-        r"""__delslice__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j)"""
-        return _libBornAgainBase.vdouble2d_t___delslice__(self, i, j)
+        r"""__delslice__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j)"""
+        return _libBornAgainBase.vdouble2d_T___delslice__(self, i, j)
 
     def __delitem__(self, *args):
         r"""
-        __delitem__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i)
-        __delitem__(vdouble2d_t self, SWIGPY_SLICEOBJECT * slice)
+        __delitem__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i)
+        __delitem__(vdouble2d_T self, SWIGPY_SLICEOBJECT * slice)
         """
-        return _libBornAgainBase.vdouble2d_t___delitem__(self, *args)
+        return _libBornAgainBase.vdouble2d_T___delitem__(self, *args)
 
     def __getitem__(self, *args):
         r"""
-        __getitem__(vdouble2d_t self, SWIGPY_SLICEOBJECT * slice) -> vdouble2d_t
-        __getitem__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i) -> vdouble1d_t
+        __getitem__(vdouble2d_T self, SWIGPY_SLICEOBJECT * slice) -> vdouble2d_T
+        __getitem__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i) -> vdouble1d_T
         """
-        return _libBornAgainBase.vdouble2d_t___getitem__(self, *args)
+        return _libBornAgainBase.vdouble2d_T___getitem__(self, *args)
 
     def __setitem__(self, *args):
         r"""
-        __setitem__(vdouble2d_t self, SWIGPY_SLICEOBJECT * slice, vdouble2d_t v)
-        __setitem__(vdouble2d_t self, SWIGPY_SLICEOBJECT * slice)
-        __setitem__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i, vdouble1d_t x)
+        __setitem__(vdouble2d_T self, SWIGPY_SLICEOBJECT * slice, vdouble2d_T v)
+        __setitem__(vdouble2d_T self, SWIGPY_SLICEOBJECT * slice)
+        __setitem__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i, vdouble1d_T x)
         """
-        return _libBornAgainBase.vdouble2d_t___setitem__(self, *args)
+        return _libBornAgainBase.vdouble2d_T___setitem__(self, *args)
 
     def pop(self):
-        r"""pop(vdouble2d_t self) -> vdouble1d_t"""
-        return _libBornAgainBase.vdouble2d_t_pop(self)
+        r"""pop(vdouble2d_T self) -> vdouble1d_T"""
+        return _libBornAgainBase.vdouble2d_T_pop(self)
 
     def append(self, x):
-        r"""append(vdouble2d_t self, vdouble1d_t x)"""
-        return _libBornAgainBase.vdouble2d_t_append(self, x)
+        r"""append(vdouble2d_T self, vdouble1d_T x)"""
+        return _libBornAgainBase.vdouble2d_T_append(self, x)
 
     def empty(self):
-        r"""empty(vdouble2d_t self) -> bool"""
-        return _libBornAgainBase.vdouble2d_t_empty(self)
+        r"""empty(vdouble2d_T self) -> bool"""
+        return _libBornAgainBase.vdouble2d_T_empty(self)
 
     def size(self):
-        r"""size(vdouble2d_t self) -> std::vector< std::vector< double > >::size_type"""
-        return _libBornAgainBase.vdouble2d_t_size(self)
+        r"""size(vdouble2d_T self) -> std::vector< std::vector< double > >::size_type"""
+        return _libBornAgainBase.vdouble2d_T_size(self)
 
     def swap(self, v):
-        r"""swap(vdouble2d_t self, vdouble2d_t v)"""
-        return _libBornAgainBase.vdouble2d_t_swap(self, v)
+        r"""swap(vdouble2d_T self, vdouble2d_T v)"""
+        return _libBornAgainBase.vdouble2d_T_swap(self, v)
 
     def begin(self):
-        r"""begin(vdouble2d_t self) -> std::vector< std::vector< double > >::iterator"""
-        return _libBornAgainBase.vdouble2d_t_begin(self)
+        r"""begin(vdouble2d_T self) -> std::vector< std::vector< double > >::iterator"""
+        return _libBornAgainBase.vdouble2d_T_begin(self)
 
     def end(self):
-        r"""end(vdouble2d_t self) -> std::vector< std::vector< double > >::iterator"""
-        return _libBornAgainBase.vdouble2d_t_end(self)
+        r"""end(vdouble2d_T self) -> std::vector< std::vector< double > >::iterator"""
+        return _libBornAgainBase.vdouble2d_T_end(self)
 
     def rbegin(self):
-        r"""rbegin(vdouble2d_t self) -> std::vector< std::vector< double > >::reverse_iterator"""
-        return _libBornAgainBase.vdouble2d_t_rbegin(self)
+        r"""rbegin(vdouble2d_T self) -> std::vector< std::vector< double > >::reverse_iterator"""
+        return _libBornAgainBase.vdouble2d_T_rbegin(self)
 
     def rend(self):
-        r"""rend(vdouble2d_t self) -> std::vector< std::vector< double > >::reverse_iterator"""
-        return _libBornAgainBase.vdouble2d_t_rend(self)
+        r"""rend(vdouble2d_T self) -> std::vector< std::vector< double > >::reverse_iterator"""
+        return _libBornAgainBase.vdouble2d_T_rend(self)
 
     def clear(self):
-        r"""clear(vdouble2d_t self)"""
-        return _libBornAgainBase.vdouble2d_t_clear(self)
+        r"""clear(vdouble2d_T self)"""
+        return _libBornAgainBase.vdouble2d_T_clear(self)
 
     def get_allocator(self):
-        r"""get_allocator(vdouble2d_t self) -> std::vector< std::vector< double > >::allocator_type"""
-        return _libBornAgainBase.vdouble2d_t_get_allocator(self)
+        r"""get_allocator(vdouble2d_T self) -> std::vector< std::vector< double > >::allocator_type"""
+        return _libBornAgainBase.vdouble2d_T_get_allocator(self)
 
     def pop_back(self):
-        r"""pop_back(vdouble2d_t self)"""
-        return _libBornAgainBase.vdouble2d_t_pop_back(self)
+        r"""pop_back(vdouble2d_T self)"""
+        return _libBornAgainBase.vdouble2d_T_pop_back(self)
 
     def erase(self, *args):
         r"""
-        erase(vdouble2d_t self, std::vector< std::vector< double > >::iterator pos) -> std::vector< std::vector< double > >::iterator
-        erase(vdouble2d_t self, std::vector< std::vector< double > >::iterator first, std::vector< std::vector< double > >::iterator last) -> std::vector< std::vector< double > >::iterator
+        erase(vdouble2d_T self, std::vector< std::vector< double > >::iterator pos) -> std::vector< std::vector< double > >::iterator
+        erase(vdouble2d_T self, std::vector< std::vector< double > >::iterator first, std::vector< std::vector< double > >::iterator last) -> std::vector< std::vector< double > >::iterator
         """
-        return _libBornAgainBase.vdouble2d_t_erase(self, *args)
+        return _libBornAgainBase.vdouble2d_T_erase(self, *args)
 
     def __init__(self, *args):
         r"""
-        __init__(vdouble2d_t self) -> vdouble2d_t
-        __init__(vdouble2d_t self, vdouble2d_t other) -> vdouble2d_t
-        __init__(vdouble2d_t self, std::vector< std::vector< double > >::size_type size) -> vdouble2d_t
-        __init__(vdouble2d_t self, std::vector< std::vector< double > >::size_type size, vdouble1d_t value) -> vdouble2d_t
+        __init__(vdouble2d_T self) -> vdouble2d_T
+        __init__(vdouble2d_T self, vdouble2d_T other) -> vdouble2d_T
+        __init__(vdouble2d_T self, std::vector< std::vector< double > >::size_type size) -> vdouble2d_T
+        __init__(vdouble2d_T self, std::vector< std::vector< double > >::size_type size, vdouble1d_T value) -> vdouble2d_T
         """
-        _libBornAgainBase.vdouble2d_t_swiginit(self, _libBornAgainBase.new_vdouble2d_t(*args))
+        _libBornAgainBase.vdouble2d_T_swiginit(self, _libBornAgainBase.new_vdouble2d_T(*args))
 
     def push_back(self, x):
-        r"""push_back(vdouble2d_t self, vdouble1d_t x)"""
-        return _libBornAgainBase.vdouble2d_t_push_back(self, x)
+        r"""push_back(vdouble2d_T self, vdouble1d_T x)"""
+        return _libBornAgainBase.vdouble2d_T_push_back(self, x)
 
     def front(self):
-        r"""front(vdouble2d_t self) -> vdouble1d_t"""
-        return _libBornAgainBase.vdouble2d_t_front(self)
+        r"""front(vdouble2d_T self) -> vdouble1d_T"""
+        return _libBornAgainBase.vdouble2d_T_front(self)
 
     def back(self):
-        r"""back(vdouble2d_t self) -> vdouble1d_t"""
-        return _libBornAgainBase.vdouble2d_t_back(self)
+        r"""back(vdouble2d_T self) -> vdouble1d_T"""
+        return _libBornAgainBase.vdouble2d_T_back(self)
 
     def assign(self, n, x):
-        r"""assign(vdouble2d_t self, std::vector< std::vector< double > >::size_type n, vdouble1d_t x)"""
-        return _libBornAgainBase.vdouble2d_t_assign(self, n, x)
+        r"""assign(vdouble2d_T self, std::vector< std::vector< double > >::size_type n, vdouble1d_T x)"""
+        return _libBornAgainBase.vdouble2d_T_assign(self, n, x)
 
     def resize(self, *args):
         r"""
-        resize(vdouble2d_t self, std::vector< std::vector< double > >::size_type new_size)
-        resize(vdouble2d_t self, std::vector< std::vector< double > >::size_type new_size, vdouble1d_t x)
+        resize(vdouble2d_T self, std::vector< std::vector< double > >::size_type new_size)
+        resize(vdouble2d_T self, std::vector< std::vector< double > >::size_type new_size, vdouble1d_T x)
         """
-        return _libBornAgainBase.vdouble2d_t_resize(self, *args)
+        return _libBornAgainBase.vdouble2d_T_resize(self, *args)
 
     def insert(self, *args):
         r"""
-        insert(vdouble2d_t self, std::vector< std::vector< double > >::iterator pos, vdouble1d_t x) -> std::vector< std::vector< double > >::iterator
-        insert(vdouble2d_t self, std::vector< std::vector< double > >::iterator pos, std::vector< std::vector< double > >::size_type n, vdouble1d_t x)
+        insert(vdouble2d_T self, std::vector< std::vector< double > >::iterator pos, vdouble1d_T x) -> std::vector< std::vector< double > >::iterator
+        insert(vdouble2d_T self, std::vector< std::vector< double > >::iterator pos, std::vector< std::vector< double > >::size_type n, vdouble1d_T x)
         """
-        return _libBornAgainBase.vdouble2d_t_insert(self, *args)
+        return _libBornAgainBase.vdouble2d_T_insert(self, *args)
 
     def reserve(self, n):
-        r"""reserve(vdouble2d_t self, std::vector< std::vector< double > >::size_type n)"""
-        return _libBornAgainBase.vdouble2d_t_reserve(self, n)
+        r"""reserve(vdouble2d_T self, std::vector< std::vector< double > >::size_type n)"""
+        return _libBornAgainBase.vdouble2d_T_reserve(self, n)
 
     def capacity(self):
-        r"""capacity(vdouble2d_t self) -> std::vector< std::vector< double > >::size_type"""
-        return _libBornAgainBase.vdouble2d_t_capacity(self)
-    __swig_destroy__ = _libBornAgainBase.delete_vdouble2d_t
+        r"""capacity(vdouble2d_T self) -> std::vector< std::vector< double > >::size_type"""
+        return _libBornAgainBase.vdouble2d_T_capacity(self)
+    __swig_destroy__ = _libBornAgainBase.delete_vdouble2d_T
 
-# Register vdouble2d_t in _libBornAgainBase:
-_libBornAgainBase.vdouble2d_t_swigregister(vdouble2d_t)
-class vector_integer_t(object):
+# Register vdouble2d_T in _libBornAgainBase:
+_libBornAgainBase.vdouble2d_T_swigregister(vdouble2d_T)
+class vector_integer_T(object):
     r"""Proxy of C++ std::vector< int > class."""
 
     thisown = property(lambda x: x.this.own(), lambda x, v: x.this.own(v), doc="The membership flag")
     __repr__ = _swig_repr
 
     def iterator(self):
-        r"""iterator(vector_integer_t self) -> SwigPyIterator"""
-        return _libBornAgainBase.vector_integer_t_iterator(self)
+        r"""iterator(vector_integer_T self) -> SwigPyIterator"""
+        return _libBornAgainBase.vector_integer_T_iterator(self)
     def __iter__(self):
         return self.iterator()
 
     def __nonzero__(self):
-        r"""__nonzero__(vector_integer_t self) -> bool"""
-        return _libBornAgainBase.vector_integer_t___nonzero__(self)
+        r"""__nonzero__(vector_integer_T self) -> bool"""
+        return _libBornAgainBase.vector_integer_T___nonzero__(self)
 
     def __bool__(self):
-        r"""__bool__(vector_integer_t self) -> bool"""
-        return _libBornAgainBase.vector_integer_t___bool__(self)
+        r"""__bool__(vector_integer_T self) -> bool"""
+        return _libBornAgainBase.vector_integer_T___bool__(self)
 
     def __len__(self):
-        r"""__len__(vector_integer_t self) -> std::vector< int >::size_type"""
-        return _libBornAgainBase.vector_integer_t___len__(self)
+        r"""__len__(vector_integer_T self) -> std::vector< int >::size_type"""
+        return _libBornAgainBase.vector_integer_T___len__(self)
 
     def __getslice__(self, i, j):
-        r"""__getslice__(vector_integer_t self, std::vector< int >::difference_type i, std::vector< int >::difference_type j) -> vector_integer_t"""
-        return _libBornAgainBase.vector_integer_t___getslice__(self, i, j)
+        r"""__getslice__(vector_integer_T self, std::vector< int >::difference_type i, std::vector< int >::difference_type j) -> vector_integer_T"""
+        return _libBornAgainBase.vector_integer_T___getslice__(self, i, j)
 
     def __setslice__(self, *args):
         r"""
-        __setslice__(vector_integer_t self, std::vector< int >::difference_type i, std::vector< int >::difference_type j)
-        __setslice__(vector_integer_t self, std::vector< int >::difference_type i, std::vector< int >::difference_type j, vector_integer_t v)
+        __setslice__(vector_integer_T self, std::vector< int >::difference_type i, std::vector< int >::difference_type j)
+        __setslice__(vector_integer_T self, std::vector< int >::difference_type i, std::vector< int >::difference_type j, vector_integer_T v)
         """
-        return _libBornAgainBase.vector_integer_t___setslice__(self, *args)
+        return _libBornAgainBase.vector_integer_T___setslice__(self, *args)
 
     def __delslice__(self, i, j):
-        r"""__delslice__(vector_integer_t self, std::vector< int >::difference_type i, std::vector< int >::difference_type j)"""
-        return _libBornAgainBase.vector_integer_t___delslice__(self, i, j)
+        r"""__delslice__(vector_integer_T self, std::vector< int >::difference_type i, std::vector< int >::difference_type j)"""
+        return _libBornAgainBase.vector_integer_T___delslice__(self, i, j)
 
     def __delitem__(self, *args):
         r"""
-        __delitem__(vector_integer_t self, std::vector< int >::difference_type i)
-        __delitem__(vector_integer_t self, SWIGPY_SLICEOBJECT * slice)
+        __delitem__(vector_integer_T self, std::vector< int >::difference_type i)
+        __delitem__(vector_integer_T self, SWIGPY_SLICEOBJECT * slice)
         """
-        return _libBornAgainBase.vector_integer_t___delitem__(self, *args)
+        return _libBornAgainBase.vector_integer_T___delitem__(self, *args)
 
     def __getitem__(self, *args):
         r"""
-        __getitem__(vector_integer_t self, SWIGPY_SLICEOBJECT * slice) -> vector_integer_t
-        __getitem__(vector_integer_t self, std::vector< int >::difference_type i) -> std::vector< int >::value_type const &
+        __getitem__(vector_integer_T self, SWIGPY_SLICEOBJECT * slice) -> vector_integer_T
+        __getitem__(vector_integer_T self, std::vector< int >::difference_type i) -> std::vector< int >::value_type const &
         """
-        return _libBornAgainBase.vector_integer_t___getitem__(self, *args)
+        return _libBornAgainBase.vector_integer_T___getitem__(self, *args)
 
     def __setitem__(self, *args):
         r"""
-        __setitem__(vector_integer_t self, SWIGPY_SLICEOBJECT * slice, vector_integer_t v)
-        __setitem__(vector_integer_t self, SWIGPY_SLICEOBJECT * slice)
-        __setitem__(vector_integer_t self, std::vector< int >::difference_type i, std::vector< int >::value_type const & x)
+        __setitem__(vector_integer_T self, SWIGPY_SLICEOBJECT * slice, vector_integer_T v)
+        __setitem__(vector_integer_T self, SWIGPY_SLICEOBJECT * slice)
+        __setitem__(vector_integer_T self, std::vector< int >::difference_type i, std::vector< int >::value_type const & x)
         """
-        return _libBornAgainBase.vector_integer_t___setitem__(self, *args)
+        return _libBornAgainBase.vector_integer_T___setitem__(self, *args)
 
     def pop(self):
-        r"""pop(vector_integer_t self) -> std::vector< int >::value_type"""
-        return _libBornAgainBase.vector_integer_t_pop(self)
+        r"""pop(vector_integer_T self) -> std::vector< int >::value_type"""
+        return _libBornAgainBase.vector_integer_T_pop(self)
 
     def append(self, x):
-        r"""append(vector_integer_t self, std::vector< int >::value_type const & x)"""
-        return _libBornAgainBase.vector_integer_t_append(self, x)
+        r"""append(vector_integer_T self, std::vector< int >::value_type const & x)"""
+        return _libBornAgainBase.vector_integer_T_append(self, x)
 
     def empty(self):
-        r"""empty(vector_integer_t self) -> bool"""
-        return _libBornAgainBase.vector_integer_t_empty(self)
+        r"""empty(vector_integer_T self) -> bool"""
+        return _libBornAgainBase.vector_integer_T_empty(self)
 
     def size(self):
-        r"""size(vector_integer_t self) -> std::vector< int >::size_type"""
-        return _libBornAgainBase.vector_integer_t_size(self)
+        r"""size(vector_integer_T self) -> std::vector< int >::size_type"""
+        return _libBornAgainBase.vector_integer_T_size(self)
 
     def swap(self, v):
-        r"""swap(vector_integer_t self, vector_integer_t v)"""
-        return _libBornAgainBase.vector_integer_t_swap(self, v)
+        r"""swap(vector_integer_T self, vector_integer_T v)"""
+        return _libBornAgainBase.vector_integer_T_swap(self, v)
 
     def begin(self):
-        r"""begin(vector_integer_t self) -> std::vector< int >::iterator"""
-        return _libBornAgainBase.vector_integer_t_begin(self)
+        r"""begin(vector_integer_T self) -> std::vector< int >::iterator"""
+        return _libBornAgainBase.vector_integer_T_begin(self)
 
     def end(self):
-        r"""end(vector_integer_t self) -> std::vector< int >::iterator"""
-        return _libBornAgainBase.vector_integer_t_end(self)
+        r"""end(vector_integer_T self) -> std::vector< int >::iterator"""
+        return _libBornAgainBase.vector_integer_T_end(self)
 
     def rbegin(self):
-        r"""rbegin(vector_integer_t self) -> std::vector< int >::reverse_iterator"""
-        return _libBornAgainBase.vector_integer_t_rbegin(self)
+        r"""rbegin(vector_integer_T self) -> std::vector< int >::reverse_iterator"""
+        return _libBornAgainBase.vector_integer_T_rbegin(self)
 
     def rend(self):
-        r"""rend(vector_integer_t self) -> std::vector< int >::reverse_iterator"""
-        return _libBornAgainBase.vector_integer_t_rend(self)
+        r"""rend(vector_integer_T self) -> std::vector< int >::reverse_iterator"""
+        return _libBornAgainBase.vector_integer_T_rend(self)
 
     def clear(self):
-        r"""clear(vector_integer_t self)"""
-        return _libBornAgainBase.vector_integer_t_clear(self)
+        r"""clear(vector_integer_T self)"""
+        return _libBornAgainBase.vector_integer_T_clear(self)
 
     def get_allocator(self):
-        r"""get_allocator(vector_integer_t self) -> std::vector< int >::allocator_type"""
-        return _libBornAgainBase.vector_integer_t_get_allocator(self)
+        r"""get_allocator(vector_integer_T self) -> std::vector< int >::allocator_type"""
+        return _libBornAgainBase.vector_integer_T_get_allocator(self)
 
     def pop_back(self):
-        r"""pop_back(vector_integer_t self)"""
-        return _libBornAgainBase.vector_integer_t_pop_back(self)
+        r"""pop_back(vector_integer_T self)"""
+        return _libBornAgainBase.vector_integer_T_pop_back(self)
 
     def erase(self, *args):
         r"""
-        erase(vector_integer_t self, std::vector< int >::iterator pos) -> std::vector< int >::iterator
-        erase(vector_integer_t self, std::vector< int >::iterator first, std::vector< int >::iterator last) -> std::vector< int >::iterator
+        erase(vector_integer_T self, std::vector< int >::iterator pos) -> std::vector< int >::iterator
+        erase(vector_integer_T self, std::vector< int >::iterator first, std::vector< int >::iterator last) -> std::vector< int >::iterator
         """
-        return _libBornAgainBase.vector_integer_t_erase(self, *args)
+        return _libBornAgainBase.vector_integer_T_erase(self, *args)
 
     def __init__(self, *args):
         r"""
-        __init__(vector_integer_t self) -> vector_integer_t
-        __init__(vector_integer_t self, vector_integer_t other) -> vector_integer_t
-        __init__(vector_integer_t self, std::vector< int >::size_type size) -> vector_integer_t
-        __init__(vector_integer_t self, std::vector< int >::size_type size, std::vector< int >::value_type const & value) -> vector_integer_t
+        __init__(vector_integer_T self) -> vector_integer_T
+        __init__(vector_integer_T self, vector_integer_T other) -> vector_integer_T
+        __init__(vector_integer_T self, std::vector< int >::size_type size) -> vector_integer_T
+        __init__(vector_integer_T self, std::vector< int >::size_type size, std::vector< int >::value_type const & value) -> vector_integer_T
         """
-        _libBornAgainBase.vector_integer_t_swiginit(self, _libBornAgainBase.new_vector_integer_t(*args))
+        _libBornAgainBase.vector_integer_T_swiginit(self, _libBornAgainBase.new_vector_integer_T(*args))
 
     def push_back(self, x):
-        r"""push_back(vector_integer_t self, std::vector< int >::value_type const & x)"""
-        return _libBornAgainBase.vector_integer_t_push_back(self, x)
+        r"""push_back(vector_integer_T self, std::vector< int >::value_type const & x)"""
+        return _libBornAgainBase.vector_integer_T_push_back(self, x)
 
     def front(self):
-        r"""front(vector_integer_t self) -> std::vector< int >::value_type const &"""
-        return _libBornAgainBase.vector_integer_t_front(self)
+        r"""front(vector_integer_T self) -> std::vector< int >::value_type const &"""
+        return _libBornAgainBase.vector_integer_T_front(self)
 
     def back(self):
-        r"""back(vector_integer_t self) -> std::vector< int >::value_type const &"""
-        return _libBornAgainBase.vector_integer_t_back(self)
+        r"""back(vector_integer_T self) -> std::vector< int >::value_type const &"""
+        return _libBornAgainBase.vector_integer_T_back(self)
 
     def assign(self, n, x):
-        r"""assign(vector_integer_t self, std::vector< int >::size_type n, std::vector< int >::value_type const & x)"""
-        return _libBornAgainBase.vector_integer_t_assign(self, n, x)
+        r"""assign(vector_integer_T self, std::vector< int >::size_type n, std::vector< int >::value_type const & x)"""
+        return _libBornAgainBase.vector_integer_T_assign(self, n, x)
 
     def resize(self, *args):
         r"""
-        resize(vector_integer_t self, std::vector< int >::size_type new_size)
-        resize(vector_integer_t self, std::vector< int >::size_type new_size, std::vector< int >::value_type const & x)
+        resize(vector_integer_T self, std::vector< int >::size_type new_size)
+        resize(vector_integer_T self, std::vector< int >::size_type new_size, std::vector< int >::value_type const & x)
         """
-        return _libBornAgainBase.vector_integer_t_resize(self, *args)
+        return _libBornAgainBase.vector_integer_T_resize(self, *args)
 
     def insert(self, *args):
         r"""
-        insert(vector_integer_t self, std::vector< int >::iterator pos, std::vector< int >::value_type const & x) -> std::vector< int >::iterator
-        insert(vector_integer_t self, std::vector< int >::iterator pos, std::vector< int >::size_type n, std::vector< int >::value_type const & x)
+        insert(vector_integer_T self, std::vector< int >::iterator pos, std::vector< int >::value_type const & x) -> std::vector< int >::iterator
+        insert(vector_integer_T self, std::vector< int >::iterator pos, std::vector< int >::size_type n, std::vector< int >::value_type const & x)
         """
-        return _libBornAgainBase.vector_integer_t_insert(self, *args)
+        return _libBornAgainBase.vector_integer_T_insert(self, *args)
 
     def reserve(self, n):
-        r"""reserve(vector_integer_t self, std::vector< int >::size_type n)"""
-        return _libBornAgainBase.vector_integer_t_reserve(self, n)
+        r"""reserve(vector_integer_T self, std::vector< int >::size_type n)"""
+        return _libBornAgainBase.vector_integer_T_reserve(self, n)
 
     def capacity(self):
-        r"""capacity(vector_integer_t self) -> std::vector< int >::size_type"""
-        return _libBornAgainBase.vector_integer_t_capacity(self)
-    __swig_destroy__ = _libBornAgainBase.delete_vector_integer_t
+        r"""capacity(vector_integer_T self) -> std::vector< int >::size_type"""
+        return _libBornAgainBase.vector_integer_T_capacity(self)
+    __swig_destroy__ = _libBornAgainBase.delete_vector_integer_T
 
-# Register vector_integer_t in _libBornAgainBase:
-_libBornAgainBase.vector_integer_t_swigregister(vector_integer_t)
-class vinteger2d_t(object):
+# Register vector_integer_T in _libBornAgainBase:
+_libBornAgainBase.vector_integer_T_swigregister(vector_integer_T)
+class vinteger2d_T(object):
     r"""Proxy of C++ std::vector< std::vector< int > > class."""
 
     thisown = property(lambda x: x.this.own(), lambda x, v: x.this.own(v), doc="The membership flag")
     __repr__ = _swig_repr
 
     def iterator(self):
-        r"""iterator(vinteger2d_t self) -> SwigPyIterator"""
-        return _libBornAgainBase.vinteger2d_t_iterator(self)
+        r"""iterator(vinteger2d_T self) -> SwigPyIterator"""
+        return _libBornAgainBase.vinteger2d_T_iterator(self)
     def __iter__(self):
         return self.iterator()
 
     def __nonzero__(self):
-        r"""__nonzero__(vinteger2d_t self) -> bool"""
-        return _libBornAgainBase.vinteger2d_t___nonzero__(self)
+        r"""__nonzero__(vinteger2d_T self) -> bool"""
+        return _libBornAgainBase.vinteger2d_T___nonzero__(self)
 
     def __bool__(self):
-        r"""__bool__(vinteger2d_t self) -> bool"""
-        return _libBornAgainBase.vinteger2d_t___bool__(self)
+        r"""__bool__(vinteger2d_T self) -> bool"""
+        return _libBornAgainBase.vinteger2d_T___bool__(self)
 
     def __len__(self):
-        r"""__len__(vinteger2d_t self) -> std::vector< std::vector< int > >::size_type"""
-        return _libBornAgainBase.vinteger2d_t___len__(self)
+        r"""__len__(vinteger2d_T self) -> std::vector< std::vector< int > >::size_type"""
+        return _libBornAgainBase.vinteger2d_T___len__(self)
 
     def __getslice__(self, i, j):
-        r"""__getslice__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j) -> vinteger2d_t"""
-        return _libBornAgainBase.vinteger2d_t___getslice__(self, i, j)
+        r"""__getslice__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j) -> vinteger2d_T"""
+        return _libBornAgainBase.vinteger2d_T___getslice__(self, i, j)
 
     def __setslice__(self, *args):
         r"""
-        __setslice__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j)
-        __setslice__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j, vinteger2d_t v)
+        __setslice__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j)
+        __setslice__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j, vinteger2d_T v)
         """
-        return _libBornAgainBase.vinteger2d_t___setslice__(self, *args)
+        return _libBornAgainBase.vinteger2d_T___setslice__(self, *args)
 
     def __delslice__(self, i, j):
-        r"""__delslice__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j)"""
-        return _libBornAgainBase.vinteger2d_t___delslice__(self, i, j)
+        r"""__delslice__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j)"""
+        return _libBornAgainBase.vinteger2d_T___delslice__(self, i, j)
 
     def __delitem__(self, *args):
         r"""
-        __delitem__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i)
-        __delitem__(vinteger2d_t self, SWIGPY_SLICEOBJECT * slice)
+        __delitem__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i)
+        __delitem__(vinteger2d_T self, SWIGPY_SLICEOBJECT * slice)
         """
-        return _libBornAgainBase.vinteger2d_t___delitem__(self, *args)
+        return _libBornAgainBase.vinteger2d_T___delitem__(self, *args)
 
     def __getitem__(self, *args):
         r"""
-        __getitem__(vinteger2d_t self, SWIGPY_SLICEOBJECT * slice) -> vinteger2d_t
-        __getitem__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i) -> vector_integer_t
+        __getitem__(vinteger2d_T self, SWIGPY_SLICEOBJECT * slice) -> vinteger2d_T
+        __getitem__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i) -> vector_integer_T
         """
-        return _libBornAgainBase.vinteger2d_t___getitem__(self, *args)
+        return _libBornAgainBase.vinteger2d_T___getitem__(self, *args)
 
     def __setitem__(self, *args):
         r"""
-        __setitem__(vinteger2d_t self, SWIGPY_SLICEOBJECT * slice, vinteger2d_t v)
-        __setitem__(vinteger2d_t self, SWIGPY_SLICEOBJECT * slice)
-        __setitem__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i, vector_integer_t x)
+        __setitem__(vinteger2d_T self, SWIGPY_SLICEOBJECT * slice, vinteger2d_T v)
+        __setitem__(vinteger2d_T self, SWIGPY_SLICEOBJECT * slice)
+        __setitem__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i, vector_integer_T x)
         """
-        return _libBornAgainBase.vinteger2d_t___setitem__(self, *args)
+        return _libBornAgainBase.vinteger2d_T___setitem__(self, *args)
 
     def pop(self):
-        r"""pop(vinteger2d_t self) -> vector_integer_t"""
-        return _libBornAgainBase.vinteger2d_t_pop(self)
+        r"""pop(vinteger2d_T self) -> vector_integer_T"""
+        return _libBornAgainBase.vinteger2d_T_pop(self)
 
     def append(self, x):
-        r"""append(vinteger2d_t self, vector_integer_t x)"""
-        return _libBornAgainBase.vinteger2d_t_append(self, x)
+        r"""append(vinteger2d_T self, vector_integer_T x)"""
+        return _libBornAgainBase.vinteger2d_T_append(self, x)
 
     def empty(self):
-        r"""empty(vinteger2d_t self) -> bool"""
-        return _libBornAgainBase.vinteger2d_t_empty(self)
+        r"""empty(vinteger2d_T self) -> bool"""
+        return _libBornAgainBase.vinteger2d_T_empty(self)
 
     def size(self):
-        r"""size(vinteger2d_t self) -> std::vector< std::vector< int > >::size_type"""
-        return _libBornAgainBase.vinteger2d_t_size(self)
+        r"""size(vinteger2d_T self) -> std::vector< std::vector< int > >::size_type"""
+        return _libBornAgainBase.vinteger2d_T_size(self)
 
     def swap(self, v):
-        r"""swap(vinteger2d_t self, vinteger2d_t v)"""
-        return _libBornAgainBase.vinteger2d_t_swap(self, v)
+        r"""swap(vinteger2d_T self, vinteger2d_T v)"""
+        return _libBornAgainBase.vinteger2d_T_swap(self, v)
 
     def begin(self):
-        r"""begin(vinteger2d_t self) -> std::vector< std::vector< int > >::iterator"""
-        return _libBornAgainBase.vinteger2d_t_begin(self)
+        r"""begin(vinteger2d_T self) -> std::vector< std::vector< int > >::iterator"""
+        return _libBornAgainBase.vinteger2d_T_begin(self)
 
     def end(self):
-        r"""end(vinteger2d_t self) -> std::vector< std::vector< int > >::iterator"""
-        return _libBornAgainBase.vinteger2d_t_end(self)
+        r"""end(vinteger2d_T self) -> std::vector< std::vector< int > >::iterator"""
+        return _libBornAgainBase.vinteger2d_T_end(self)
 
     def rbegin(self):
-        r"""rbegin(vinteger2d_t self) -> std::vector< std::vector< int > >::reverse_iterator"""
-        return _libBornAgainBase.vinteger2d_t_rbegin(self)
+        r"""rbegin(vinteger2d_T self) -> std::vector< std::vector< int > >::reverse_iterator"""
+        return _libBornAgainBase.vinteger2d_T_rbegin(self)
 
     def rend(self):
-        r"""rend(vinteger2d_t self) -> std::vector< std::vector< int > >::reverse_iterator"""
-        return _libBornAgainBase.vinteger2d_t_rend(self)
+        r"""rend(vinteger2d_T self) -> std::vector< std::vector< int > >::reverse_iterator"""
+        return _libBornAgainBase.vinteger2d_T_rend(self)
 
     def clear(self):
-        r"""clear(vinteger2d_t self)"""
-        return _libBornAgainBase.vinteger2d_t_clear(self)
+        r"""clear(vinteger2d_T self)"""
+        return _libBornAgainBase.vinteger2d_T_clear(self)
 
     def get_allocator(self):
-        r"""get_allocator(vinteger2d_t self) -> std::vector< std::vector< int > >::allocator_type"""
-        return _libBornAgainBase.vinteger2d_t_get_allocator(self)
+        r"""get_allocator(vinteger2d_T self) -> std::vector< std::vector< int > >::allocator_type"""
+        return _libBornAgainBase.vinteger2d_T_get_allocator(self)
 
     def pop_back(self):
-        r"""pop_back(vinteger2d_t self)"""
-        return _libBornAgainBase.vinteger2d_t_pop_back(self)
+        r"""pop_back(vinteger2d_T self)"""
+        return _libBornAgainBase.vinteger2d_T_pop_back(self)
 
     def erase(self, *args):
         r"""
-        erase(vinteger2d_t self, std::vector< std::vector< int > >::iterator pos) -> std::vector< std::vector< int > >::iterator
-        erase(vinteger2d_t self, std::vector< std::vector< int > >::iterator first, std::vector< std::vector< int > >::iterator last) -> std::vector< std::vector< int > >::iterator
+        erase(vinteger2d_T self, std::vector< std::vector< int > >::iterator pos) -> std::vector< std::vector< int > >::iterator
+        erase(vinteger2d_T self, std::vector< std::vector< int > >::iterator first, std::vector< std::vector< int > >::iterator last) -> std::vector< std::vector< int > >::iterator
         """
-        return _libBornAgainBase.vinteger2d_t_erase(self, *args)
+        return _libBornAgainBase.vinteger2d_T_erase(self, *args)
 
     def __init__(self, *args):
         r"""
-        __init__(vinteger2d_t self) -> vinteger2d_t
-        __init__(vinteger2d_t self, vinteger2d_t other) -> vinteger2d_t
-        __init__(vinteger2d_t self, std::vector< std::vector< int > >::size_type size) -> vinteger2d_t
-        __init__(vinteger2d_t self, std::vector< std::vector< int > >::size_type size, vector_integer_t value) -> vinteger2d_t
+        __init__(vinteger2d_T self) -> vinteger2d_T
+        __init__(vinteger2d_T self, vinteger2d_T other) -> vinteger2d_T
+        __init__(vinteger2d_T self, std::vector< std::vector< int > >::size_type size) -> vinteger2d_T
+        __init__(vinteger2d_T self, std::vector< std::vector< int > >::size_type size, vector_integer_T value) -> vinteger2d_T
         """
-        _libBornAgainBase.vinteger2d_t_swiginit(self, _libBornAgainBase.new_vinteger2d_t(*args))
+        _libBornAgainBase.vinteger2d_T_swiginit(self, _libBornAgainBase.new_vinteger2d_T(*args))
 
     def push_back(self, x):
-        r"""push_back(vinteger2d_t self, vector_integer_t x)"""
-        return _libBornAgainBase.vinteger2d_t_push_back(self, x)
+        r"""push_back(vinteger2d_T self, vector_integer_T x)"""
+        return _libBornAgainBase.vinteger2d_T_push_back(self, x)
 
     def front(self):
-        r"""front(vinteger2d_t self) -> vector_integer_t"""
-        return _libBornAgainBase.vinteger2d_t_front(self)
+        r"""front(vinteger2d_T self) -> vector_integer_T"""
+        return _libBornAgainBase.vinteger2d_T_front(self)
 
     def back(self):
-        r"""back(vinteger2d_t self) -> vector_integer_t"""
-        return _libBornAgainBase.vinteger2d_t_back(self)
+        r"""back(vinteger2d_T self) -> vector_integer_T"""
+        return _libBornAgainBase.vinteger2d_T_back(self)
 
     def assign(self, n, x):
-        r"""assign(vinteger2d_t self, std::vector< std::vector< int > >::size_type n, vector_integer_t x)"""
-        return _libBornAgainBase.vinteger2d_t_assign(self, n, x)
+        r"""assign(vinteger2d_T self, std::vector< std::vector< int > >::size_type n, vector_integer_T x)"""
+        return _libBornAgainBase.vinteger2d_T_assign(self, n, x)
 
     def resize(self, *args):
         r"""
-        resize(vinteger2d_t self, std::vector< std::vector< int > >::size_type new_size)
-        resize(vinteger2d_t self, std::vector< std::vector< int > >::size_type new_size, vector_integer_t x)
+        resize(vinteger2d_T self, std::vector< std::vector< int > >::size_type new_size)
+        resize(vinteger2d_T self, std::vector< std::vector< int > >::size_type new_size, vector_integer_T x)
         """
-        return _libBornAgainBase.vinteger2d_t_resize(self, *args)
+        return _libBornAgainBase.vinteger2d_T_resize(self, *args)
 
     def insert(self, *args):
         r"""
-        insert(vinteger2d_t self, std::vector< std::vector< int > >::iterator pos, vector_integer_t x) -> std::vector< std::vector< int > >::iterator
-        insert(vinteger2d_t self, std::vector< std::vector< int > >::iterator pos, std::vector< std::vector< int > >::size_type n, vector_integer_t x)
+        insert(vinteger2d_T self, std::vector< std::vector< int > >::iterator pos, vector_integer_T x) -> std::vector< std::vector< int > >::iterator
+        insert(vinteger2d_T self, std::vector< std::vector< int > >::iterator pos, std::vector< std::vector< int > >::size_type n, vector_integer_T x)
         """
-        return _libBornAgainBase.vinteger2d_t_insert(self, *args)
+        return _libBornAgainBase.vinteger2d_T_insert(self, *args)
 
     def reserve(self, n):
-        r"""reserve(vinteger2d_t self, std::vector< std::vector< int > >::size_type n)"""
-        return _libBornAgainBase.vinteger2d_t_reserve(self, n)
+        r"""reserve(vinteger2d_T self, std::vector< std::vector< int > >::size_type n)"""
+        return _libBornAgainBase.vinteger2d_T_reserve(self, n)
 
     def capacity(self):
-        r"""capacity(vinteger2d_t self) -> std::vector< std::vector< int > >::size_type"""
-        return _libBornAgainBase.vinteger2d_t_capacity(self)
-    __swig_destroy__ = _libBornAgainBase.delete_vinteger2d_t
+        r"""capacity(vinteger2d_T self) -> std::vector< std::vector< int > >::size_type"""
+        return _libBornAgainBase.vinteger2d_T_capacity(self)
+    __swig_destroy__ = _libBornAgainBase.delete_vinteger2d_T
 
-# Register vinteger2d_t in _libBornAgainBase:
-_libBornAgainBase.vinteger2d_t_swigregister(vinteger2d_t)
-class vector_longinteger_t(object):
+# Register vinteger2d_T in _libBornAgainBase:
+_libBornAgainBase.vinteger2d_T_swigregister(vinteger2d_T)
+class vector_longinteger_T(object):
     r"""Proxy of C++ std::vector< unsigned long > class."""
 
     thisown = property(lambda x: x.this.own(), lambda x, v: x.this.own(v), doc="The membership flag")
     __repr__ = _swig_repr
 
     def iterator(self):
-        r"""iterator(vector_longinteger_t self) -> SwigPyIterator"""
-        return _libBornAgainBase.vector_longinteger_t_iterator(self)
+        r"""iterator(vector_longinteger_T self) -> SwigPyIterator"""
+        return _libBornAgainBase.vector_longinteger_T_iterator(self)
     def __iter__(self):
         return self.iterator()
 
     def __nonzero__(self):
-        r"""__nonzero__(vector_longinteger_t self) -> bool"""
-        return _libBornAgainBase.vector_longinteger_t___nonzero__(self)
+        r"""__nonzero__(vector_longinteger_T self) -> bool"""
+        return _libBornAgainBase.vector_longinteger_T___nonzero__(self)
 
     def __bool__(self):
-        r"""__bool__(vector_longinteger_t self) -> bool"""
-        return _libBornAgainBase.vector_longinteger_t___bool__(self)
+        r"""__bool__(vector_longinteger_T self) -> bool"""
+        return _libBornAgainBase.vector_longinteger_T___bool__(self)
 
     def __len__(self):
-        r"""__len__(vector_longinteger_t self) -> std::vector< unsigned long >::size_type"""
-        return _libBornAgainBase.vector_longinteger_t___len__(self)
+        r"""__len__(vector_longinteger_T self) -> std::vector< unsigned long >::size_type"""
+        return _libBornAgainBase.vector_longinteger_T___len__(self)
 
     def __getslice__(self, i, j):
-        r"""__getslice__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j) -> vector_longinteger_t"""
-        return _libBornAgainBase.vector_longinteger_t___getslice__(self, i, j)
+        r"""__getslice__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j) -> vector_longinteger_T"""
+        return _libBornAgainBase.vector_longinteger_T___getslice__(self, i, j)
 
     def __setslice__(self, *args):
         r"""
-        __setslice__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j)
-        __setslice__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j, vector_longinteger_t v)
+        __setslice__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j)
+        __setslice__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j, vector_longinteger_T v)
         """
-        return _libBornAgainBase.vector_longinteger_t___setslice__(self, *args)
+        return _libBornAgainBase.vector_longinteger_T___setslice__(self, *args)
 
     def __delslice__(self, i, j):
-        r"""__delslice__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j)"""
-        return _libBornAgainBase.vector_longinteger_t___delslice__(self, i, j)
+        r"""__delslice__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j)"""
+        return _libBornAgainBase.vector_longinteger_T___delslice__(self, i, j)
 
     def __delitem__(self, *args):
         r"""
-        __delitem__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i)
-        __delitem__(vector_longinteger_t self, SWIGPY_SLICEOBJECT * slice)
+        __delitem__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i)
+        __delitem__(vector_longinteger_T self, SWIGPY_SLICEOBJECT * slice)
         """
-        return _libBornAgainBase.vector_longinteger_t___delitem__(self, *args)
+        return _libBornAgainBase.vector_longinteger_T___delitem__(self, *args)
 
     def __getitem__(self, *args):
         r"""
-        __getitem__(vector_longinteger_t self, SWIGPY_SLICEOBJECT * slice) -> vector_longinteger_t
-        __getitem__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i) -> std::vector< unsigned long >::value_type const &
+        __getitem__(vector_longinteger_T self, SWIGPY_SLICEOBJECT * slice) -> vector_longinteger_T
+        __getitem__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i) -> std::vector< unsigned long >::value_type const &
         """
-        return _libBornAgainBase.vector_longinteger_t___getitem__(self, *args)
+        return _libBornAgainBase.vector_longinteger_T___getitem__(self, *args)
 
     def __setitem__(self, *args):
         r"""
-        __setitem__(vector_longinteger_t self, SWIGPY_SLICEOBJECT * slice, vector_longinteger_t v)
-        __setitem__(vector_longinteger_t self, SWIGPY_SLICEOBJECT * slice)
-        __setitem__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::value_type const & x)
+        __setitem__(vector_longinteger_T self, SWIGPY_SLICEOBJECT * slice, vector_longinteger_T v)
+        __setitem__(vector_longinteger_T self, SWIGPY_SLICEOBJECT * slice)
+        __setitem__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::value_type const & x)
         """
-        return _libBornAgainBase.vector_longinteger_t___setitem__(self, *args)
+        return _libBornAgainBase.vector_longinteger_T___setitem__(self, *args)
 
     def pop(self):
-        r"""pop(vector_longinteger_t self) -> std::vector< unsigned long >::value_type"""
-        return _libBornAgainBase.vector_longinteger_t_pop(self)
+        r"""pop(vector_longinteger_T self) -> std::vector< unsigned long >::value_type"""
+        return _libBornAgainBase.vector_longinteger_T_pop(self)
 
     def append(self, x):
-        r"""append(vector_longinteger_t self, std::vector< unsigned long >::value_type const & x)"""
-        return _libBornAgainBase.vector_longinteger_t_append(self, x)
+        r"""append(vector_longinteger_T self, std::vector< unsigned long >::value_type const & x)"""
+        return _libBornAgainBase.vector_longinteger_T_append(self, x)
 
     def empty(self):
-        r"""empty(vector_longinteger_t self) -> bool"""
-        return _libBornAgainBase.vector_longinteger_t_empty(self)
+        r"""empty(vector_longinteger_T self) -> bool"""
+        return _libBornAgainBase.vector_longinteger_T_empty(self)
 
     def size(self):
-        r"""size(vector_longinteger_t self) -> std::vector< unsigned long >::size_type"""
-        return _libBornAgainBase.vector_longinteger_t_size(self)
+        r"""size(vector_longinteger_T self) -> std::vector< unsigned long >::size_type"""
+        return _libBornAgainBase.vector_longinteger_T_size(self)
 
     def swap(self, v):
-        r"""swap(vector_longinteger_t self, vector_longinteger_t v)"""
-        return _libBornAgainBase.vector_longinteger_t_swap(self, v)
+        r"""swap(vector_longinteger_T self, vector_longinteger_T v)"""
+        return _libBornAgainBase.vector_longinteger_T_swap(self, v)
 
     def begin(self):
-        r"""begin(vector_longinteger_t self) -> std::vector< unsigned long >::iterator"""
-        return _libBornAgainBase.vector_longinteger_t_begin(self)
+        r"""begin(vector_longinteger_T self) -> std::vector< unsigned long >::iterator"""
+        return _libBornAgainBase.vector_longinteger_T_begin(self)
 
     def end(self):
-        r"""end(vector_longinteger_t self) -> std::vector< unsigned long >::iterator"""
-        return _libBornAgainBase.vector_longinteger_t_end(self)
+        r"""end(vector_longinteger_T self) -> std::vector< unsigned long >::iterator"""
+        return _libBornAgainBase.vector_longinteger_T_end(self)
 
     def rbegin(self):
-        r"""rbegin(vector_longinteger_t self) -> std::vector< unsigned long >::reverse_iterator"""
-        return _libBornAgainBase.vector_longinteger_t_rbegin(self)
+        r"""rbegin(vector_longinteger_T self) -> std::vector< unsigned long >::reverse_iterator"""
+        return _libBornAgainBase.vector_longinteger_T_rbegin(self)
 
     def rend(self):
-        r"""rend(vector_longinteger_t self) -> std::vector< unsigned long >::reverse_iterator"""
-        return _libBornAgainBase.vector_longinteger_t_rend(self)
+        r"""rend(vector_longinteger_T self) -> std::vector< unsigned long >::reverse_iterator"""
+        return _libBornAgainBase.vector_longinteger_T_rend(self)
 
     def clear(self):
-        r"""clear(vector_longinteger_t self)"""
-        return _libBornAgainBase.vector_longinteger_t_clear(self)
+        r"""clear(vector_longinteger_T self)"""
+        return _libBornAgainBase.vector_longinteger_T_clear(self)
 
     def get_allocator(self):
-        r"""get_allocator(vector_longinteger_t self) -> std::vector< unsigned long >::allocator_type"""
-        return _libBornAgainBase.vector_longinteger_t_get_allocator(self)
+        r"""get_allocator(vector_longinteger_T self) -> std::vector< unsigned long >::allocator_type"""
+        return _libBornAgainBase.vector_longinteger_T_get_allocator(self)
 
     def pop_back(self):
-        r"""pop_back(vector_longinteger_t self)"""
-        return _libBornAgainBase.vector_longinteger_t_pop_back(self)
+        r"""pop_back(vector_longinteger_T self)"""
+        return _libBornAgainBase.vector_longinteger_T_pop_back(self)
 
     def erase(self, *args):
         r"""
-        erase(vector_longinteger_t self, std::vector< unsigned long >::iterator pos) -> std::vector< unsigned long >::iterator
-        erase(vector_longinteger_t self, std::vector< unsigned long >::iterator first, std::vector< unsigned long >::iterator last) -> std::vector< unsigned long >::iterator
+        erase(vector_longinteger_T self, std::vector< unsigned long >::iterator pos) -> std::vector< unsigned long >::iterator
+        erase(vector_longinteger_T self, std::vector< unsigned long >::iterator first, std::vector< unsigned long >::iterator last) -> std::vector< unsigned long >::iterator
         """
-        return _libBornAgainBase.vector_longinteger_t_erase(self, *args)
+        return _libBornAgainBase.vector_longinteger_T_erase(self, *args)
 
     def __init__(self, *args):
         r"""
-        __init__(vector_longinteger_t self) -> vector_longinteger_t
-        __init__(vector_longinteger_t self, vector_longinteger_t other) -> vector_longinteger_t
-        __init__(vector_longinteger_t self, std::vector< unsigned long >::size_type size) -> vector_longinteger_t
-        __init__(vector_longinteger_t self, std::vector< unsigned long >::size_type size, std::vector< unsigned long >::value_type const & value) -> vector_longinteger_t
+        __init__(vector_longinteger_T self) -> vector_longinteger_T
+        __init__(vector_longinteger_T self, vector_longinteger_T other) -> vector_longinteger_T
+        __init__(vector_longinteger_T self, std::vector< unsigned long >::size_type size) -> vector_longinteger_T
+        __init__(vector_longinteger_T self, std::vector< unsigned long >::size_type size, std::vector< unsigned long >::value_type const & value) -> vector_longinteger_T
         """
-        _libBornAgainBase.vector_longinteger_t_swiginit(self, _libBornAgainBase.new_vector_longinteger_t(*args))
+        _libBornAgainBase.vector_longinteger_T_swiginit(self, _libBornAgainBase.new_vector_longinteger_T(*args))
 
     def push_back(self, x):
-        r"""push_back(vector_longinteger_t self, std::vector< unsigned long >::value_type const & x)"""
-        return _libBornAgainBase.vector_longinteger_t_push_back(self, x)
+        r"""push_back(vector_longinteger_T self, std::vector< unsigned long >::value_type const & x)"""
+        return _libBornAgainBase.vector_longinteger_T_push_back(self, x)
 
     def front(self):
-        r"""front(vector_longinteger_t self) -> std::vector< unsigned long >::value_type const &"""
-        return _libBornAgainBase.vector_longinteger_t_front(self)
+        r"""front(vector_longinteger_T self) -> std::vector< unsigned long >::value_type const &"""
+        return _libBornAgainBase.vector_longinteger_T_front(self)
 
     def back(self):
-        r"""back(vector_longinteger_t self) -> std::vector< unsigned long >::value_type const &"""
-        return _libBornAgainBase.vector_longinteger_t_back(self)
+        r"""back(vector_longinteger_T self) -> std::vector< unsigned long >::value_type const &"""
+        return _libBornAgainBase.vector_longinteger_T_back(self)
 
     def assign(self, n, x):
-        r"""assign(vector_longinteger_t self, std::vector< unsigned long >::size_type n, std::vector< unsigned long >::value_type const & x)"""
-        return _libBornAgainBase.vector_longinteger_t_assign(self, n, x)
+        r"""assign(vector_longinteger_T self, std::vector< unsigned long >::size_type n, std::vector< unsigned long >::value_type const & x)"""
+        return _libBornAgainBase.vector_longinteger_T_assign(self, n, x)
 
     def resize(self, *args):
         r"""
-        resize(vector_longinteger_t self, std::vector< unsigned long >::size_type new_size)
-        resize(vector_longinteger_t self, std::vector< unsigned long >::size_type new_size, std::vector< unsigned long >::value_type const & x)
+        resize(vector_longinteger_T self, std::vector< unsigned long >::size_type new_size)
+        resize(vector_longinteger_T self, std::vector< unsigned long >::size_type new_size, std::vector< unsigned long >::value_type const & x)
         """
-        return _libBornAgainBase.vector_longinteger_t_resize(self, *args)
+        return _libBornAgainBase.vector_longinteger_T_resize(self, *args)
 
     def insert(self, *args):
         r"""
-        insert(vector_longinteger_t self, std::vector< unsigned long >::iterator pos, std::vector< unsigned long >::value_type const & x) -> std::vector< unsigned long >::iterator
-        insert(vector_longinteger_t self, std::vector< unsigned long >::iterator pos, std::vector< unsigned long >::size_type n, std::vector< unsigned long >::value_type const & x)
+        insert(vector_longinteger_T self, std::vector< unsigned long >::iterator pos, std::vector< unsigned long >::value_type const & x) -> std::vector< unsigned long >::iterator
+        insert(vector_longinteger_T self, std::vector< unsigned long >::iterator pos, std::vector< unsigned long >::size_type n, std::vector< unsigned long >::value_type const & x)
         """
-        return _libBornAgainBase.vector_longinteger_t_insert(self, *args)
+        return _libBornAgainBase.vector_longinteger_T_insert(self, *args)
 
     def reserve(self, n):
-        r"""reserve(vector_longinteger_t self, std::vector< unsigned long >::size_type n)"""
-        return _libBornAgainBase.vector_longinteger_t_reserve(self, n)
+        r"""reserve(vector_longinteger_T self, std::vector< unsigned long >::size_type n)"""
+        return _libBornAgainBase.vector_longinteger_T_reserve(self, n)
 
     def capacity(self):
-        r"""capacity(vector_longinteger_t self) -> std::vector< unsigned long >::size_type"""
-        return _libBornAgainBase.vector_longinteger_t_capacity(self)
-    __swig_destroy__ = _libBornAgainBase.delete_vector_longinteger_t
+        r"""capacity(vector_longinteger_T self) -> std::vector< unsigned long >::size_type"""
+        return _libBornAgainBase.vector_longinteger_T_capacity(self)
+    __swig_destroy__ = _libBornAgainBase.delete_vector_longinteger_T
 
-# Register vector_longinteger_t in _libBornAgainBase:
-_libBornAgainBase.vector_longinteger_t_swigregister(vector_longinteger_t)
-class vector_complex_t(object):
+# Register vector_longinteger_T in _libBornAgainBase:
+_libBornAgainBase.vector_longinteger_T_swigregister(vector_longinteger_T)
+class vector_complex_T(object):
     r"""Proxy of C++ std::vector< std::complex< double > > class."""
 
     thisown = property(lambda x: x.this.own(), lambda x, v: x.this.own(v), doc="The membership flag")
     __repr__ = _swig_repr
 
     def iterator(self):
-        r"""iterator(vector_complex_t self) -> SwigPyIterator"""
-        return _libBornAgainBase.vector_complex_t_iterator(self)
+        r"""iterator(vector_complex_T self) -> SwigPyIterator"""
+        return _libBornAgainBase.vector_complex_T_iterator(self)
     def __iter__(self):
         return self.iterator()
 
     def __nonzero__(self):
-        r"""__nonzero__(vector_complex_t self) -> bool"""
-        return _libBornAgainBase.vector_complex_t___nonzero__(self)
+        r"""__nonzero__(vector_complex_T self) -> bool"""
+        return _libBornAgainBase.vector_complex_T___nonzero__(self)
 
     def __bool__(self):
-        r"""__bool__(vector_complex_t self) -> bool"""
-        return _libBornAgainBase.vector_complex_t___bool__(self)
+        r"""__bool__(vector_complex_T self) -> bool"""
+        return _libBornAgainBase.vector_complex_T___bool__(self)
 
     def __len__(self):
-        r"""__len__(vector_complex_t self) -> std::vector< std::complex< double > >::size_type"""
-        return _libBornAgainBase.vector_complex_t___len__(self)
+        r"""__len__(vector_complex_T self) -> std::vector< std::complex< double > >::size_type"""
+        return _libBornAgainBase.vector_complex_T___len__(self)
 
     def __getslice__(self, i, j):
-        r"""__getslice__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j) -> vector_complex_t"""
-        return _libBornAgainBase.vector_complex_t___getslice__(self, i, j)
+        r"""__getslice__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j) -> vector_complex_T"""
+        return _libBornAgainBase.vector_complex_T___getslice__(self, i, j)
 
     def __setslice__(self, *args):
         r"""
-        __setslice__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j)
-        __setslice__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j, vector_complex_t v)
+        __setslice__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j)
+        __setslice__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j, vector_complex_T v)
         """
-        return _libBornAgainBase.vector_complex_t___setslice__(self, *args)
+        return _libBornAgainBase.vector_complex_T___setslice__(self, *args)
 
     def __delslice__(self, i, j):
-        r"""__delslice__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j)"""
-        return _libBornAgainBase.vector_complex_t___delslice__(self, i, j)
+        r"""__delslice__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j)"""
+        return _libBornAgainBase.vector_complex_T___delslice__(self, i, j)
 
     def __delitem__(self, *args):
         r"""
-        __delitem__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i)
-        __delitem__(vector_complex_t self, SWIGPY_SLICEOBJECT * slice)
+        __delitem__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i)
+        __delitem__(vector_complex_T self, SWIGPY_SLICEOBJECT * slice)
         """
-        return _libBornAgainBase.vector_complex_t___delitem__(self, *args)
+        return _libBornAgainBase.vector_complex_T___delitem__(self, *args)
 
     def __getitem__(self, *args):
         r"""
-        __getitem__(vector_complex_t self, SWIGPY_SLICEOBJECT * slice) -> vector_complex_t
-        __getitem__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i) -> std::vector< std::complex< double > >::value_type const &
+        __getitem__(vector_complex_T self, SWIGPY_SLICEOBJECT * slice) -> vector_complex_T
+        __getitem__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i) -> std::vector< std::complex< double > >::value_type const &
         """
-        return _libBornAgainBase.vector_complex_t___getitem__(self, *args)
+        return _libBornAgainBase.vector_complex_T___getitem__(self, *args)
 
     def __setitem__(self, *args):
         r"""
-        __setitem__(vector_complex_t self, SWIGPY_SLICEOBJECT * slice, vector_complex_t v)
-        __setitem__(vector_complex_t self, SWIGPY_SLICEOBJECT * slice)
-        __setitem__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::value_type const & x)
+        __setitem__(vector_complex_T self, SWIGPY_SLICEOBJECT * slice, vector_complex_T v)
+        __setitem__(vector_complex_T self, SWIGPY_SLICEOBJECT * slice)
+        __setitem__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::value_type const & x)
         """
-        return _libBornAgainBase.vector_complex_t___setitem__(self, *args)
+        return _libBornAgainBase.vector_complex_T___setitem__(self, *args)
 
     def pop(self):
-        r"""pop(vector_complex_t self) -> std::vector< std::complex< double > >::value_type"""
-        return _libBornAgainBase.vector_complex_t_pop(self)
+        r"""pop(vector_complex_T self) -> std::vector< std::complex< double > >::value_type"""
+        return _libBornAgainBase.vector_complex_T_pop(self)
 
     def append(self, x):
-        r"""append(vector_complex_t self, std::vector< std::complex< double > >::value_type const & x)"""
-        return _libBornAgainBase.vector_complex_t_append(self, x)
+        r"""append(vector_complex_T self, std::vector< std::complex< double > >::value_type const & x)"""
+        return _libBornAgainBase.vector_complex_T_append(self, x)
 
     def empty(self):
-        r"""empty(vector_complex_t self) -> bool"""
-        return _libBornAgainBase.vector_complex_t_empty(self)
+        r"""empty(vector_complex_T self) -> bool"""
+        return _libBornAgainBase.vector_complex_T_empty(self)
 
     def size(self):
-        r"""size(vector_complex_t self) -> std::vector< std::complex< double > >::size_type"""
-        return _libBornAgainBase.vector_complex_t_size(self)
+        r"""size(vector_complex_T self) -> std::vector< std::complex< double > >::size_type"""
+        return _libBornAgainBase.vector_complex_T_size(self)
 
     def swap(self, v):
-        r"""swap(vector_complex_t self, vector_complex_t v)"""
-        return _libBornAgainBase.vector_complex_t_swap(self, v)
+        r"""swap(vector_complex_T self, vector_complex_T v)"""
+        return _libBornAgainBase.vector_complex_T_swap(self, v)
 
     def begin(self):
-        r"""begin(vector_complex_t self) -> std::vector< std::complex< double > >::iterator"""
-        return _libBornAgainBase.vector_complex_t_begin(self)
+        r"""begin(vector_complex_T self) -> std::vector< std::complex< double > >::iterator"""
+        return _libBornAgainBase.vector_complex_T_begin(self)
 
     def end(self):
-        r"""end(vector_complex_t self) -> std::vector< std::complex< double > >::iterator"""
-        return _libBornAgainBase.vector_complex_t_end(self)
+        r"""end(vector_complex_T self) -> std::vector< std::complex< double > >::iterator"""
+        return _libBornAgainBase.vector_complex_T_end(self)
 
     def rbegin(self):
-        r"""rbegin(vector_complex_t self) -> std::vector< std::complex< double > >::reverse_iterator"""
-        return _libBornAgainBase.vector_complex_t_rbegin(self)
+        r"""rbegin(vector_complex_T self) -> std::vector< std::complex< double > >::reverse_iterator"""
+        return _libBornAgainBase.vector_complex_T_rbegin(self)
 
     def rend(self):
-        r"""rend(vector_complex_t self) -> std::vector< std::complex< double > >::reverse_iterator"""
-        return _libBornAgainBase.vector_complex_t_rend(self)
+        r"""rend(vector_complex_T self) -> std::vector< std::complex< double > >::reverse_iterator"""
+        return _libBornAgainBase.vector_complex_T_rend(self)
 
     def clear(self):
-        r"""clear(vector_complex_t self)"""
-        return _libBornAgainBase.vector_complex_t_clear(self)
+        r"""clear(vector_complex_T self)"""
+        return _libBornAgainBase.vector_complex_T_clear(self)
 
     def get_allocator(self):
-        r"""get_allocator(vector_complex_t self) -> std::vector< std::complex< double > >::allocator_type"""
-        return _libBornAgainBase.vector_complex_t_get_allocator(self)
+        r"""get_allocator(vector_complex_T self) -> std::vector< std::complex< double > >::allocator_type"""
+        return _libBornAgainBase.vector_complex_T_get_allocator(self)
 
     def pop_back(self):
-        r"""pop_back(vector_complex_t self)"""
-        return _libBornAgainBase.vector_complex_t_pop_back(self)
+        r"""pop_back(vector_complex_T self)"""
+        return _libBornAgainBase.vector_complex_T_pop_back(self)
 
     def erase(self, *args):
         r"""
-        erase(vector_complex_t self, std::vector< std::complex< double > >::iterator pos) -> std::vector< std::complex< double > >::iterator
-        erase(vector_complex_t self, std::vector< std::complex< double > >::iterator first, std::vector< std::complex< double > >::iterator last) -> std::vector< std::complex< double > >::iterator
+        erase(vector_complex_T self, std::vector< std::complex< double > >::iterator pos) -> std::vector< std::complex< double > >::iterator
+        erase(vector_complex_T self, std::vector< std::complex< double > >::iterator first, std::vector< std::complex< double > >::iterator last) -> std::vector< std::complex< double > >::iterator
         """
-        return _libBornAgainBase.vector_complex_t_erase(self, *args)
+        return _libBornAgainBase.vector_complex_T_erase(self, *args)
 
     def __init__(self, *args):
         r"""
-        __init__(vector_complex_t self) -> vector_complex_t
-        __init__(vector_complex_t self, vector_complex_t other) -> vector_complex_t
-        __init__(vector_complex_t self, std::vector< std::complex< double > >::size_type size) -> vector_complex_t
-        __init__(vector_complex_t self, std::vector< std::complex< double > >::size_type size, std::vector< std::complex< double > >::value_type const & value) -> vector_complex_t
+        __init__(vector_complex_T self) -> vector_complex_T
+        __init__(vector_complex_T self, vector_complex_T other) -> vector_complex_T
+        __init__(vector_complex_T self, std::vector< std::complex< double > >::size_type size) -> vector_complex_T
+        __init__(vector_complex_T self, std::vector< std::complex< double > >::size_type size, std::vector< std::complex< double > >::value_type const & value) -> vector_complex_T
         """
-        _libBornAgainBase.vector_complex_t_swiginit(self, _libBornAgainBase.new_vector_complex_t(*args))
+        _libBornAgainBase.vector_complex_T_swiginit(self, _libBornAgainBase.new_vector_complex_T(*args))
 
     def push_back(self, x):
-        r"""push_back(vector_complex_t self, std::vector< std::complex< double > >::value_type const & x)"""
-        return _libBornAgainBase.vector_complex_t_push_back(self, x)
+        r"""push_back(vector_complex_T self, std::vector< std::complex< double > >::value_type const & x)"""
+        return _libBornAgainBase.vector_complex_T_push_back(self, x)
 
     def front(self):
-        r"""front(vector_complex_t self) -> std::vector< std::complex< double > >::value_type const &"""
-        return _libBornAgainBase.vector_complex_t_front(self)
+        r"""front(vector_complex_T self) -> std::vector< std::complex< double > >::value_type const &"""
+        return _libBornAgainBase.vector_complex_T_front(self)
 
     def back(self):
-        r"""back(vector_complex_t self) -> std::vector< std::complex< double > >::value_type const &"""
-        return _libBornAgainBase.vector_complex_t_back(self)
+        r"""back(vector_complex_T self) -> std::vector< std::complex< double > >::value_type const &"""
+        return _libBornAgainBase.vector_complex_T_back(self)
 
     def assign(self, n, x):
-        r"""assign(vector_complex_t self, std::vector< std::complex< double > >::size_type n, std::vector< std::complex< double > >::value_type const & x)"""
-        return _libBornAgainBase.vector_complex_t_assign(self, n, x)
+        r"""assign(vector_complex_T self, std::vector< std::complex< double > >::size_type n, std::vector< std::complex< double > >::value_type const & x)"""
+        return _libBornAgainBase.vector_complex_T_assign(self, n, x)
 
     def resize(self, *args):
         r"""
-        resize(vector_complex_t self, std::vector< std::complex< double > >::size_type new_size)
-        resize(vector_complex_t self, std::vector< std::complex< double > >::size_type new_size, std::vector< std::complex< double > >::value_type const & x)
+        resize(vector_complex_T self, std::vector< std::complex< double > >::size_type new_size)
+        resize(vector_complex_T self, std::vector< std::complex< double > >::size_type new_size, std::vector< std::complex< double > >::value_type const & x)
         """
-        return _libBornAgainBase.vector_complex_t_resize(self, *args)
+        return _libBornAgainBase.vector_complex_T_resize(self, *args)
 
     def insert(self, *args):
         r"""
-        insert(vector_complex_t self, std::vector< std::complex< double > >::iterator pos, std::vector< std::complex< double > >::value_type const & x) -> std::vector< std::complex< double > >::iterator
-        insert(vector_complex_t self, std::vector< std::complex< double > >::iterator pos, std::vector< std::complex< double > >::size_type n, std::vector< std::complex< double > >::value_type const & x)
+        insert(vector_complex_T self, std::vector< std::complex< double > >::iterator pos, std::vector< std::complex< double > >::value_type const & x) -> std::vector< std::complex< double > >::iterator
+        insert(vector_complex_T self, std::vector< std::complex< double > >::iterator pos, std::vector< std::complex< double > >::size_type n, std::vector< std::complex< double > >::value_type const & x)
         """
-        return _libBornAgainBase.vector_complex_t_insert(self, *args)
+        return _libBornAgainBase.vector_complex_T_insert(self, *args)
 
     def reserve(self, n):
-        r"""reserve(vector_complex_t self, std::vector< std::complex< double > >::size_type n)"""
-        return _libBornAgainBase.vector_complex_t_reserve(self, n)
+        r"""reserve(vector_complex_T self, std::vector< std::complex< double > >::size_type n)"""
+        return _libBornAgainBase.vector_complex_T_reserve(self, n)
 
     def capacity(self):
-        r"""capacity(vector_complex_t self) -> std::vector< std::complex< double > >::size_type"""
-        return _libBornAgainBase.vector_complex_t_capacity(self)
-    __swig_destroy__ = _libBornAgainBase.delete_vector_complex_t
+        r"""capacity(vector_complex_T self) -> std::vector< std::complex< double > >::size_type"""
+        return _libBornAgainBase.vector_complex_T_capacity(self)
+    __swig_destroy__ = _libBornAgainBase.delete_vector_complex_T
 
-# Register vector_complex_t in _libBornAgainBase:
-_libBornAgainBase.vector_complex_t_swigregister(vector_complex_t)
-class vector_string_t(object):
+# Register vector_complex_T in _libBornAgainBase:
+_libBornAgainBase.vector_complex_T_swigregister(vector_complex_T)
+class vector_string_T(object):
     r"""Proxy of C++ std::vector< std::string > class."""
 
     thisown = property(lambda x: x.this.own(), lambda x, v: x.this.own(v), doc="The membership flag")
     __repr__ = _swig_repr
 
     def iterator(self):
-        r"""iterator(vector_string_t self) -> SwigPyIterator"""
-        return _libBornAgainBase.vector_string_t_iterator(self)
+        r"""iterator(vector_string_T self) -> SwigPyIterator"""
+        return _libBornAgainBase.vector_string_T_iterator(self)
     def __iter__(self):
         return self.iterator()
 
     def __nonzero__(self):
-        r"""__nonzero__(vector_string_t self) -> bool"""
-        return _libBornAgainBase.vector_string_t___nonzero__(self)
+        r"""__nonzero__(vector_string_T self) -> bool"""
+        return _libBornAgainBase.vector_string_T___nonzero__(self)
 
     def __bool__(self):
-        r"""__bool__(vector_string_t self) -> bool"""
-        return _libBornAgainBase.vector_string_t___bool__(self)
+        r"""__bool__(vector_string_T self) -> bool"""
+        return _libBornAgainBase.vector_string_T___bool__(self)
 
     def __len__(self):
-        r"""__len__(vector_string_t self) -> std::vector< std::string >::size_type"""
-        return _libBornAgainBase.vector_string_t___len__(self)
+        r"""__len__(vector_string_T self) -> std::vector< std::string >::size_type"""
+        return _libBornAgainBase.vector_string_T___len__(self)
 
     def __getslice__(self, i, j):
-        r"""__getslice__(vector_string_t self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j) -> vector_string_t"""
-        return _libBornAgainBase.vector_string_t___getslice__(self, i, j)
+        r"""__getslice__(vector_string_T self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j) -> vector_string_T"""
+        return _libBornAgainBase.vector_string_T___getslice__(self, i, j)
 
     def __setslice__(self, *args):
         r"""
-        __setslice__(vector_string_t self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j)
-        __setslice__(vector_string_t self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j, vector_string_t v)
+        __setslice__(vector_string_T self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j)
+        __setslice__(vector_string_T self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j, vector_string_T v)
         """
-        return _libBornAgainBase.vector_string_t___setslice__(self, *args)
+        return _libBornAgainBase.vector_string_T___setslice__(self, *args)
 
     def __delslice__(self, i, j):
-        r"""__delslice__(vector_string_t self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j)"""
-        return _libBornAgainBase.vector_string_t___delslice__(self, i, j)
+        r"""__delslice__(vector_string_T self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j)"""
+        return _libBornAgainBase.vector_string_T___delslice__(self, i, j)
 
     def __delitem__(self, *args):
         r"""
-        __delitem__(vector_string_t self, std::vector< std::string >::difference_type i)
-        __delitem__(vector_string_t self, SWIGPY_SLICEOBJECT * slice)
+        __delitem__(vector_string_T self, std::vector< std::string >::difference_type i)
+        __delitem__(vector_string_T self, SWIGPY_SLICEOBJECT * slice)
         """
-        return _libBornAgainBase.vector_string_t___delitem__(self, *args)
+        return _libBornAgainBase.vector_string_T___delitem__(self, *args)
 
     def __getitem__(self, *args):
         r"""
-        __getitem__(vector_string_t self, SWIGPY_SLICEOBJECT * slice) -> vector_string_t
-        __getitem__(vector_string_t self, std::vector< std::string >::difference_type i) -> std::vector< std::string >::value_type const &
+        __getitem__(vector_string_T self, SWIGPY_SLICEOBJECT * slice) -> vector_string_T
+        __getitem__(vector_string_T self, std::vector< std::string >::difference_type i) -> std::vector< std::string >::value_type const &
         """
-        return _libBornAgainBase.vector_string_t___getitem__(self, *args)
+        return _libBornAgainBase.vector_string_T___getitem__(self, *args)
 
     def __setitem__(self, *args):
         r"""
-        __setitem__(vector_string_t self, SWIGPY_SLICEOBJECT * slice, vector_string_t v)
-        __setitem__(vector_string_t self, SWIGPY_SLICEOBJECT * slice)
-        __setitem__(vector_string_t self, std::vector< std::string >::difference_type i, std::vector< std::string >::value_type const & x)
+        __setitem__(vector_string_T self, SWIGPY_SLICEOBJECT * slice, vector_string_T v)
+        __setitem__(vector_string_T self, SWIGPY_SLICEOBJECT * slice)
+        __setitem__(vector_string_T self, std::vector< std::string >::difference_type i, std::vector< std::string >::value_type const & x)
         """
-        return _libBornAgainBase.vector_string_t___setitem__(self, *args)
+        return _libBornAgainBase.vector_string_T___setitem__(self, *args)
 
     def pop(self):
-        r"""pop(vector_string_t self) -> std::vector< std::string >::value_type"""
-        return _libBornAgainBase.vector_string_t_pop(self)
+        r"""pop(vector_string_T self) -> std::vector< std::string >::value_type"""
+        return _libBornAgainBase.vector_string_T_pop(self)
 
     def append(self, x):
-        r"""append(vector_string_t self, std::vector< std::string >::value_type const & x)"""
-        return _libBornAgainBase.vector_string_t_append(self, x)
+        r"""append(vector_string_T self, std::vector< std::string >::value_type const & x)"""
+        return _libBornAgainBase.vector_string_T_append(self, x)
 
     def empty(self):
-        r"""empty(vector_string_t self) -> bool"""
-        return _libBornAgainBase.vector_string_t_empty(self)
+        r"""empty(vector_string_T self) -> bool"""
+        return _libBornAgainBase.vector_string_T_empty(self)
 
     def size(self):
-        r"""size(vector_string_t self) -> std::vector< std::string >::size_type"""
-        return _libBornAgainBase.vector_string_t_size(self)
+        r"""size(vector_string_T self) -> std::vector< std::string >::size_type"""
+        return _libBornAgainBase.vector_string_T_size(self)
 
     def swap(self, v):
-        r"""swap(vector_string_t self, vector_string_t v)"""
-        return _libBornAgainBase.vector_string_t_swap(self, v)
+        r"""swap(vector_string_T self, vector_string_T v)"""
+        return _libBornAgainBase.vector_string_T_swap(self, v)
 
     def begin(self):
-        r"""begin(vector_string_t self) -> std::vector< std::string >::iterator"""
-        return _libBornAgainBase.vector_string_t_begin(self)
+        r"""begin(vector_string_T self) -> std::vector< std::string >::iterator"""
+        return _libBornAgainBase.vector_string_T_begin(self)
 
     def end(self):
-        r"""end(vector_string_t self) -> std::vector< std::string >::iterator"""
-        return _libBornAgainBase.vector_string_t_end(self)
+        r"""end(vector_string_T self) -> std::vector< std::string >::iterator"""
+        return _libBornAgainBase.vector_string_T_end(self)
 
     def rbegin(self):
-        r"""rbegin(vector_string_t self) -> std::vector< std::string >::reverse_iterator"""
-        return _libBornAgainBase.vector_string_t_rbegin(self)
+        r"""rbegin(vector_string_T self) -> std::vector< std::string >::reverse_iterator"""
+        return _libBornAgainBase.vector_string_T_rbegin(self)
 
     def rend(self):
-        r"""rend(vector_string_t self) -> std::vector< std::string >::reverse_iterator"""
-        return _libBornAgainBase.vector_string_t_rend(self)
+        r"""rend(vector_string_T self) -> std::vector< std::string >::reverse_iterator"""
+        return _libBornAgainBase.vector_string_T_rend(self)
 
     def clear(self):
-        r"""clear(vector_string_t self)"""
-        return _libBornAgainBase.vector_string_t_clear(self)
+        r"""clear(vector_string_T self)"""
+        return _libBornAgainBase.vector_string_T_clear(self)
 
     def get_allocator(self):
-        r"""get_allocator(vector_string_t self) -> std::vector< std::string >::allocator_type"""
-        return _libBornAgainBase.vector_string_t_get_allocator(self)
+        r"""get_allocator(vector_string_T self) -> std::vector< std::string >::allocator_type"""
+        return _libBornAgainBase.vector_string_T_get_allocator(self)
 
     def pop_back(self):
-        r"""pop_back(vector_string_t self)"""
-        return _libBornAgainBase.vector_string_t_pop_back(self)
+        r"""pop_back(vector_string_T self)"""
+        return _libBornAgainBase.vector_string_T_pop_back(self)
 
     def erase(self, *args):
         r"""
-        erase(vector_string_t self, std::vector< std::string >::iterator pos) -> std::vector< std::string >::iterator
-        erase(vector_string_t self, std::vector< std::string >::iterator first, std::vector< std::string >::iterator last) -> std::vector< std::string >::iterator
+        erase(vector_string_T self, std::vector< std::string >::iterator pos) -> std::vector< std::string >::iterator
+        erase(vector_string_T self, std::vector< std::string >::iterator first, std::vector< std::string >::iterator last) -> std::vector< std::string >::iterator
         """
-        return _libBornAgainBase.vector_string_t_erase(self, *args)
+        return _libBornAgainBase.vector_string_T_erase(self, *args)
 
     def __init__(self, *args):
         r"""
-        __init__(vector_string_t self) -> vector_string_t
-        __init__(vector_string_t self, vector_string_t other) -> vector_string_t
-        __init__(vector_string_t self, std::vector< std::string >::size_type size) -> vector_string_t
-        __init__(vector_string_t self, std::vector< std::string >::size_type size, std::vector< std::string >::value_type const & value) -> vector_string_t
+        __init__(vector_string_T self) -> vector_string_T
+        __init__(vector_string_T self, vector_string_T other) -> vector_string_T
+        __init__(vector_string_T self, std::vector< std::string >::size_type size) -> vector_string_T
+        __init__(vector_string_T self, std::vector< std::string >::size_type size, std::vector< std::string >::value_type const & value) -> vector_string_T
         """
-        _libBornAgainBase.vector_string_t_swiginit(self, _libBornAgainBase.new_vector_string_t(*args))
+        _libBornAgainBase.vector_string_T_swiginit(self, _libBornAgainBase.new_vector_string_T(*args))
 
     def push_back(self, x):
-        r"""push_back(vector_string_t self, std::vector< std::string >::value_type const & x)"""
-        return _libBornAgainBase.vector_string_t_push_back(self, x)
+        r"""push_back(vector_string_T self, std::vector< std::string >::value_type const & x)"""
+        return _libBornAgainBase.vector_string_T_push_back(self, x)
 
     def front(self):
-        r"""front(vector_string_t self) -> std::vector< std::string >::value_type const &"""
-        return _libBornAgainBase.vector_string_t_front(self)
+        r"""front(vector_string_T self) -> std::vector< std::string >::value_type const &"""
+        return _libBornAgainBase.vector_string_T_front(self)
 
     def back(self):
-        r"""back(vector_string_t self) -> std::vector< std::string >::value_type const &"""
-        return _libBornAgainBase.vector_string_t_back(self)
+        r"""back(vector_string_T self) -> std::vector< std::string >::value_type const &"""
+        return _libBornAgainBase.vector_string_T_back(self)
 
     def assign(self, n, x):
-        r"""assign(vector_string_t self, std::vector< std::string >::size_type n, std::vector< std::string >::value_type const & x)"""
-        return _libBornAgainBase.vector_string_t_assign(self, n, x)
+        r"""assign(vector_string_T self, std::vector< std::string >::size_type n, std::vector< std::string >::value_type const & x)"""
+        return _libBornAgainBase.vector_string_T_assign(self, n, x)
 
     def resize(self, *args):
         r"""
-        resize(vector_string_t self, std::vector< std::string >::size_type new_size)
-        resize(vector_string_t self, std::vector< std::string >::size_type new_size, std::vector< std::string >::value_type const & x)
+        resize(vector_string_T self, std::vector< std::string >::size_type new_size)
+        resize(vector_string_T self, std::vector< std::string >::size_type new_size, std::vector< std::string >::value_type const & x)
         """
-        return _libBornAgainBase.vector_string_t_resize(self, *args)
+        return _libBornAgainBase.vector_string_T_resize(self, *args)
 
     def insert(self, *args):
         r"""
-        insert(vector_string_t self, std::vector< std::string >::iterator pos, std::vector< std::string >::value_type const & x) -> std::vector< std::string >::iterator
-        insert(vector_string_t self, std::vector< std::string >::iterator pos, std::vector< std::string >::size_type n, std::vector< std::string >::value_type const & x)
+        insert(vector_string_T self, std::vector< std::string >::iterator pos, std::vector< std::string >::value_type const & x) -> std::vector< std::string >::iterator
+        insert(vector_string_T self, std::vector< std::string >::iterator pos, std::vector< std::string >::size_type n, std::vector< std::string >::value_type const & x)
         """
-        return _libBornAgainBase.vector_string_t_insert(self, *args)
+        return _libBornAgainBase.vector_string_T_insert(self, *args)
 
     def reserve(self, n):
-        r"""reserve(vector_string_t self, std::vector< std::string >::size_type n)"""
-        return _libBornAgainBase.vector_string_t_reserve(self, n)
+        r"""reserve(vector_string_T self, std::vector< std::string >::size_type n)"""
+        return _libBornAgainBase.vector_string_T_reserve(self, n)
 
     def capacity(self):
-        r"""capacity(vector_string_t self) -> std::vector< std::string >::size_type"""
-        return _libBornAgainBase.vector_string_t_capacity(self)
-    __swig_destroy__ = _libBornAgainBase.delete_vector_string_t
+        r"""capacity(vector_string_T self) -> std::vector< std::string >::size_type"""
+        return _libBornAgainBase.vector_string_T_capacity(self)
+    __swig_destroy__ = _libBornAgainBase.delete_vector_string_T
 
-# Register vector_string_t in _libBornAgainBase:
-_libBornAgainBase.vector_string_t_swigregister(vector_string_t)
-class map_string_double_t(object):
+# Register vector_string_T in _libBornAgainBase:
+_libBornAgainBase.vector_string_T_swigregister(vector_string_T)
+class map_string_double_T(object):
     r"""Proxy of C++ std::map< std::string,double > class."""
 
     thisown = property(lambda x: x.this.own(), lambda x, v: x.this.own(v), doc="The membership flag")
     __repr__ = _swig_repr
 
     def iterator(self):
-        r"""iterator(map_string_double_t self) -> SwigPyIterator"""
-        return _libBornAgainBase.map_string_double_t_iterator(self)
+        r"""iterator(map_string_double_T self) -> SwigPyIterator"""
+        return _libBornAgainBase.map_string_double_T_iterator(self)
     def __iter__(self):
         return self.iterator()
 
     def __nonzero__(self):
-        r"""__nonzero__(map_string_double_t self) -> bool"""
-        return _libBornAgainBase.map_string_double_t___nonzero__(self)
+        r"""__nonzero__(map_string_double_T self) -> bool"""
+        return _libBornAgainBase.map_string_double_T___nonzero__(self)
 
     def __bool__(self):
-        r"""__bool__(map_string_double_t self) -> bool"""
-        return _libBornAgainBase.map_string_double_t___bool__(self)
+        r"""__bool__(map_string_double_T self) -> bool"""
+        return _libBornAgainBase.map_string_double_T___bool__(self)
 
     def __len__(self):
-        r"""__len__(map_string_double_t self) -> std::map< std::string,double >::size_type"""
-        return _libBornAgainBase.map_string_double_t___len__(self)
+        r"""__len__(map_string_double_T self) -> std::map< std::string,double >::size_type"""
+        return _libBornAgainBase.map_string_double_T___len__(self)
     def __iter__(self):
         return self.key_iterator()
     def iterkeys(self):
@@ -1348,124 +1348,124 @@ class map_string_double_t(object):
         return self.iterator()
 
     def __getitem__(self, key):
-        r"""__getitem__(map_string_double_t self, std::map< std::string,double >::key_type const & key) -> std::map< std::string,double >::mapped_type const &"""
-        return _libBornAgainBase.map_string_double_t___getitem__(self, key)
+        r"""__getitem__(map_string_double_T self, std::map< std::string,double >::key_type const & key) -> std::map< std::string,double >::mapped_type const &"""
+        return _libBornAgainBase.map_string_double_T___getitem__(self, key)
 
     def __delitem__(self, key):
-        r"""__delitem__(map_string_double_t self, std::map< std::string,double >::key_type const & key)"""
-        return _libBornAgainBase.map_string_double_t___delitem__(self, key)
+        r"""__delitem__(map_string_double_T self, std::map< std::string,double >::key_type const & key)"""
+        return _libBornAgainBase.map_string_double_T___delitem__(self, key)
 
     def has_key(self, key):
-        r"""has_key(map_string_double_t self, std::map< std::string,double >::key_type const & key) -> bool"""
-        return _libBornAgainBase.map_string_double_t_has_key(self, key)
+        r"""has_key(map_string_double_T self, std::map< std::string,double >::key_type const & key) -> bool"""
+        return _libBornAgainBase.map_string_double_T_has_key(self, key)
 
     def keys(self):
-        r"""keys(map_string_double_t self) -> PyObject *"""
-        return _libBornAgainBase.map_string_double_t_keys(self)
+        r"""keys(map_string_double_T self) -> PyObject *"""
+        return _libBornAgainBase.map_string_double_T_keys(self)
 
     def values(self):
-        r"""values(map_string_double_t self) -> PyObject *"""
-        return _libBornAgainBase.map_string_double_t_values(self)
+        r"""values(map_string_double_T self) -> PyObject *"""
+        return _libBornAgainBase.map_string_double_T_values(self)
 
     def items(self):
-        r"""items(map_string_double_t self) -> PyObject *"""
-        return _libBornAgainBase.map_string_double_t_items(self)
+        r"""items(map_string_double_T self) -> PyObject *"""
+        return _libBornAgainBase.map_string_double_T_items(self)
 
     def __contains__(self, key):
-        r"""__contains__(map_string_double_t self, std::map< std::string,double >::key_type const & key) -> bool"""
-        return _libBornAgainBase.map_string_double_t___contains__(self, key)
+        r"""__contains__(map_string_double_T self, std::map< std::string,double >::key_type const & key) -> bool"""
+        return _libBornAgainBase.map_string_double_T___contains__(self, key)
 
     def key_iterator(self):
-        r"""key_iterator(map_string_double_t self) -> SwigPyIterator"""
-        return _libBornAgainBase.map_string_double_t_key_iterator(self)
+        r"""key_iterator(map_string_double_T self) -> SwigPyIterator"""
+        return _libBornAgainBase.map_string_double_T_key_iterator(self)
 
     def value_iterator(self):
-        r"""value_iterator(map_string_double_t self) -> SwigPyIterator"""
-        return _libBornAgainBase.map_string_double_t_value_iterator(self)
+        r"""value_iterator(map_string_double_T self) -> SwigPyIterator"""
+        return _libBornAgainBase.map_string_double_T_value_iterator(self)
 
     def __setitem__(self, *args):
         r"""
-        __setitem__(map_string_double_t self, std::map< std::string,double >::key_type const & key)
-        __setitem__(map_string_double_t self, std::map< std::string,double >::key_type const & key, std::map< std::string,double >::mapped_type const & x)
+        __setitem__(map_string_double_T self, std::map< std::string,double >::key_type const & key)
+        __setitem__(map_string_double_T self, std::map< std::string,double >::key_type const & key, std::map< std::string,double >::mapped_type const & x)
         """
-        return _libBornAgainBase.map_string_double_t___setitem__(self, *args)
+        return _libBornAgainBase.map_string_double_T___setitem__(self, *args)
 
     def asdict(self):
-        r"""asdict(map_string_double_t self) -> PyObject *"""
-        return _libBornAgainBase.map_string_double_t_asdict(self)
+        r"""asdict(map_string_double_T self) -> PyObject *"""
+        return _libBornAgainBase.map_string_double_T_asdict(self)
 
     def __init__(self, *args):
         r"""
-        __init__(map_string_double_t self, std::less< std::string > const & other) -> map_string_double_t
-        __init__(map_string_double_t self) -> map_string_double_t
-        __init__(map_string_double_t self, map_string_double_t other) -> map_string_double_t
+        __init__(map_string_double_T self, std::less< std::string > const & other) -> map_string_double_T
+        __init__(map_string_double_T self) -> map_string_double_T
+        __init__(map_string_double_T self, map_string_double_T other) -> map_string_double_T
         """
-        _libBornAgainBase.map_string_double_t_swiginit(self, _libBornAgainBase.new_map_string_double_t(*args))
+        _libBornAgainBase.map_string_double_T_swiginit(self, _libBornAgainBase.new_map_string_double_T(*args))
 
     def empty(self):
-        r"""empty(map_string_double_t self) -> bool"""
-        return _libBornAgainBase.map_string_double_t_empty(self)
+        r"""empty(map_string_double_T self) -> bool"""
+        return _libBornAgainBase.map_string_double_T_empty(self)
 
     def size(self):
-        r"""size(map_string_double_t self) -> std::map< std::string,double >::size_type"""
-        return _libBornAgainBase.map_string_double_t_size(self)
+        r"""size(map_string_double_T self) -> std::map< std::string,double >::size_type"""
+        return _libBornAgainBase.map_string_double_T_size(self)
 
     def swap(self, v):
-        r"""swap(map_string_double_t self, map_string_double_t v)"""
-        return _libBornAgainBase.map_string_double_t_swap(self, v)
+        r"""swap(map_string_double_T self, map_string_double_T v)"""
+        return _libBornAgainBase.map_string_double_T_swap(self, v)
 
     def begin(self):
-        r"""begin(map_string_double_t self) -> std::map< std::string,double >::iterator"""
-        return _libBornAgainBase.map_string_double_t_begin(self)
+        r"""begin(map_string_double_T self) -> std::map< std::string,double >::iterator"""
+        return _libBornAgainBase.map_string_double_T_begin(self)
 
     def end(self):
-        r"""end(map_string_double_t self) -> std::map< std::string,double >::iterator"""
-        return _libBornAgainBase.map_string_double_t_end(self)
+        r"""end(map_string_double_T self) -> std::map< std::string,double >::iterator"""
+        return _libBornAgainBase.map_string_double_T_end(self)
 
     def rbegin(self):
-        r"""rbegin(map_string_double_t self) -> std::map< std::string,double >::reverse_iterator"""
-        return _libBornAgainBase.map_string_double_t_rbegin(self)
+        r"""rbegin(map_string_double_T self) -> std::map< std::string,double >::reverse_iterator"""
+        return _libBornAgainBase.map_string_double_T_rbegin(self)
 
     def rend(self):
-        r"""rend(map_string_double_t self) -> std::map< std::string,double >::reverse_iterator"""
-        return _libBornAgainBase.map_string_double_t_rend(self)
+        r"""rend(map_string_double_T self) -> std::map< std::string,double >::reverse_iterator"""
+        return _libBornAgainBase.map_string_double_T_rend(self)
 
     def clear(self):
-        r"""clear(map_string_double_t self)"""
-        return _libBornAgainBase.map_string_double_t_clear(self)
+        r"""clear(map_string_double_T self)"""
+        return _libBornAgainBase.map_string_double_T_clear(self)
 
     def get_allocator(self):
-        r"""get_allocator(map_string_double_t self) -> std::map< std::string,double >::allocator_type"""
-        return _libBornAgainBase.map_string_double_t_get_allocator(self)
+        r"""get_allocator(map_string_double_T self) -> std::map< std::string,double >::allocator_type"""
+        return _libBornAgainBase.map_string_double_T_get_allocator(self)
 
     def count(self, x):
-        r"""count(map_string_double_t self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::size_type"""
-        return _libBornAgainBase.map_string_double_t_count(self, x)
+        r"""count(map_string_double_T self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::size_type"""
+        return _libBornAgainBase.map_string_double_T_count(self, x)
 
     def erase(self, *args):
         r"""
-        erase(map_string_double_t self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::size_type
-        erase(map_string_double_t self, std::map< std::string,double >::iterator position)
-        erase(map_string_double_t self, std::map< std::string,double >::iterator first, std::map< std::string,double >::iterator last)
+        erase(map_string_double_T self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::size_type
+        erase(map_string_double_T self, std::map< std::string,double >::iterator position)
+        erase(map_string_double_T self, std::map< std::string,double >::iterator first, std::map< std::string,double >::iterator last)
         """
-        return _libBornAgainBase.map_string_double_t_erase(self, *args)
+        return _libBornAgainBase.map_string_double_T_erase(self, *args)
 
     def find(self, x):
-        r"""find(map_string_double_t self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"""
-        return _libBornAgainBase.map_string_double_t_find(self, x)
+        r"""find(map_string_double_T self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"""
+        return _libBornAgainBase.map_string_double_T_find(self, x)
 
     def lower_bound(self, x):
-        r"""lower_bound(map_string_double_t self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"""
-        return _libBornAgainBase.map_string_double_t_lower_bound(self, x)
+        r"""lower_bound(map_string_double_T self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"""
+        return _libBornAgainBase.map_string_double_T_lower_bound(self, x)
 
     def upper_bound(self, x):
-        r"""upper_bound(map_string_double_t self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"""
-        return _libBornAgainBase.map_string_double_t_upper_bound(self, x)
-    __swig_destroy__ = _libBornAgainBase.delete_map_string_double_t
+        r"""upper_bound(map_string_double_T self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"""
+        return _libBornAgainBase.map_string_double_T_upper_bound(self, x)
+    __swig_destroy__ = _libBornAgainBase.delete_map_string_double_T
 
-# Register map_string_double_t in _libBornAgainBase:
-_libBornAgainBase.map_string_double_t_swigregister(map_string_double_t)
-class pvacuum_double_t(object):
+# Register map_string_double_T in _libBornAgainBase:
+_libBornAgainBase.map_string_double_T_swigregister(map_string_double_T)
+class pvacuum_double_T(object):
     r"""Proxy of C++ std::pair< double,double > class."""
 
     thisown = property(lambda x: x.this.own(), lambda x, v: x.this.own(v), doc="The membership flag")
@@ -1473,13 +1473,13 @@ class pvacuum_double_t(object):
 
     def __init__(self, *args):
         r"""
-        __init__(pvacuum_double_t self) -> pvacuum_double_t
-        __init__(pvacuum_double_t self, double first, double second) -> pvacuum_double_t
-        __init__(pvacuum_double_t self, pvacuum_double_t other) -> pvacuum_double_t
+        __init__(pvacuum_double_T self) -> pvacuum_double_T
+        __init__(pvacuum_double_T self, double first, double second) -> pvacuum_double_T
+        __init__(pvacuum_double_T self, pvacuum_double_T other) -> pvacuum_double_T
         """
-        _libBornAgainBase.pvacuum_double_t_swiginit(self, _libBornAgainBase.new_pvacuum_double_t(*args))
-    first = property(_libBornAgainBase.pvacuum_double_t_first_get, _libBornAgainBase.pvacuum_double_t_first_set, doc=r"""first : double""")
-    second = property(_libBornAgainBase.pvacuum_double_t_second_get, _libBornAgainBase.pvacuum_double_t_second_set, doc=r"""second : double""")
+        _libBornAgainBase.pvacuum_double_T_swiginit(self, _libBornAgainBase.new_pvacuum_double_T(*args))
+    first = property(_libBornAgainBase.pvacuum_double_T_first_get, _libBornAgainBase.pvacuum_double_T_first_set, doc=r"""first : double""")
+    second = property(_libBornAgainBase.pvacuum_double_T_second_get, _libBornAgainBase.pvacuum_double_T_second_set, doc=r"""second : double""")
     def __len__(self):
         return 2
     def __repr__(self):
@@ -1494,176 +1494,176 @@ class pvacuum_double_t(object):
             self.first = val
         else:
             self.second = val
-    __swig_destroy__ = _libBornAgainBase.delete_pvacuum_double_t
+    __swig_destroy__ = _libBornAgainBase.delete_pvacuum_double_T
 
-# Register pvacuum_double_t in _libBornAgainBase:
-_libBornAgainBase.pvacuum_double_t_swigregister(pvacuum_double_t)
-class vector_pvacuum_double_t(object):
+# Register pvacuum_double_T in _libBornAgainBase:
+_libBornAgainBase.pvacuum_double_T_swigregister(pvacuum_double_T)
+class vector_pvacuum_double_T(object):
     r"""Proxy of C++ std::vector< std::pair< double,double > > class."""
 
     thisown = property(lambda x: x.this.own(), lambda x, v: x.this.own(v), doc="The membership flag")
     __repr__ = _swig_repr
 
     def iterator(self):
-        r"""iterator(vector_pvacuum_double_t self) -> SwigPyIterator"""
-        return _libBornAgainBase.vector_pvacuum_double_t_iterator(self)
+        r"""iterator(vector_pvacuum_double_T self) -> SwigPyIterator"""
+        return _libBornAgainBase.vector_pvacuum_double_T_iterator(self)
     def __iter__(self):
         return self.iterator()
 
     def __nonzero__(self):
-        r"""__nonzero__(vector_pvacuum_double_t self) -> bool"""
-        return _libBornAgainBase.vector_pvacuum_double_t___nonzero__(self)
+        r"""__nonzero__(vector_pvacuum_double_T self) -> bool"""
+        return _libBornAgainBase.vector_pvacuum_double_T___nonzero__(self)
 
     def __bool__(self):
-        r"""__bool__(vector_pvacuum_double_t self) -> bool"""
-        return _libBornAgainBase.vector_pvacuum_double_t___bool__(self)
+        r"""__bool__(vector_pvacuum_double_T self) -> bool"""
+        return _libBornAgainBase.vector_pvacuum_double_T___bool__(self)
 
     def __len__(self):
-        r"""__len__(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::size_type"""
-        return _libBornAgainBase.vector_pvacuum_double_t___len__(self)
+        r"""__len__(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::size_type"""
+        return _libBornAgainBase.vector_pvacuum_double_T___len__(self)
 
     def __getslice__(self, i, j):
-        r"""__getslice__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j) -> vector_pvacuum_double_t"""
-        return _libBornAgainBase.vector_pvacuum_double_t___getslice__(self, i, j)
+        r"""__getslice__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j) -> vector_pvacuum_double_T"""
+        return _libBornAgainBase.vector_pvacuum_double_T___getslice__(self, i, j)
 
     def __setslice__(self, *args):
         r"""
-        __setslice__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j)
-        __setslice__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j, vector_pvacuum_double_t v)
+        __setslice__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j)
+        __setslice__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j, vector_pvacuum_double_T v)
         """
-        return _libBornAgainBase.vector_pvacuum_double_t___setslice__(self, *args)
+        return _libBornAgainBase.vector_pvacuum_double_T___setslice__(self, *args)
 
     def __delslice__(self, i, j):
-        r"""__delslice__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j)"""
-        return _libBornAgainBase.vector_pvacuum_double_t___delslice__(self, i, j)
+        r"""__delslice__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j)"""
+        return _libBornAgainBase.vector_pvacuum_double_T___delslice__(self, i, j)
 
     def __delitem__(self, *args):
         r"""
-        __delitem__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i)
-        __delitem__(vector_pvacuum_double_t self, SWIGPY_SLICEOBJECT * slice)
+        __delitem__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i)
+        __delitem__(vector_pvacuum_double_T self, SWIGPY_SLICEOBJECT * slice)
         """
-        return _libBornAgainBase.vector_pvacuum_double_t___delitem__(self, *args)
+        return _libBornAgainBase.vector_pvacuum_double_T___delitem__(self, *args)
 
     def __getitem__(self, *args):
         r"""
-        __getitem__(vector_pvacuum_double_t self, SWIGPY_SLICEOBJECT * slice) -> vector_pvacuum_double_t
-        __getitem__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i) -> pvacuum_double_t
+        __getitem__(vector_pvacuum_double_T self, SWIGPY_SLICEOBJECT * slice) -> vector_pvacuum_double_T
+        __getitem__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i) -> pvacuum_double_T
         """
-        return _libBornAgainBase.vector_pvacuum_double_t___getitem__(self, *args)
+        return _libBornAgainBase.vector_pvacuum_double_T___getitem__(self, *args)
 
     def __setitem__(self, *args):
         r"""
-        __setitem__(vector_pvacuum_double_t self, SWIGPY_SLICEOBJECT * slice, vector_pvacuum_double_t v)
-        __setitem__(vector_pvacuum_double_t self, SWIGPY_SLICEOBJECT * slice)
-        __setitem__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i, pvacuum_double_t x)
+        __setitem__(vector_pvacuum_double_T self, SWIGPY_SLICEOBJECT * slice, vector_pvacuum_double_T v)
+        __setitem__(vector_pvacuum_double_T self, SWIGPY_SLICEOBJECT * slice)
+        __setitem__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i, pvacuum_double_T x)
         """
-        return _libBornAgainBase.vector_pvacuum_double_t___setitem__(self, *args)
+        return _libBornAgainBase.vector_pvacuum_double_T___setitem__(self, *args)
 
     def pop(self):
-        r"""pop(vector_pvacuum_double_t self) -> pvacuum_double_t"""
-        return _libBornAgainBase.vector_pvacuum_double_t_pop(self)
+        r"""pop(vector_pvacuum_double_T self) -> pvacuum_double_T"""
+        return _libBornAgainBase.vector_pvacuum_double_T_pop(self)
 
     def append(self, x):
-        r"""append(vector_pvacuum_double_t self, pvacuum_double_t x)"""
-        return _libBornAgainBase.vector_pvacuum_double_t_append(self, x)
+        r"""append(vector_pvacuum_double_T self, pvacuum_double_T x)"""
+        return _libBornAgainBase.vector_pvacuum_double_T_append(self, x)
 
     def empty(self):
-        r"""empty(vector_pvacuum_double_t self) -> bool"""
-        return _libBornAgainBase.vector_pvacuum_double_t_empty(self)
+        r"""empty(vector_pvacuum_double_T self) -> bool"""
+        return _libBornAgainBase.vector_pvacuum_double_T_empty(self)
 
     def size(self):
-        r"""size(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::size_type"""
-        return _libBornAgainBase.vector_pvacuum_double_t_size(self)
+        r"""size(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::size_type"""
+        return _libBornAgainBase.vector_pvacuum_double_T_size(self)
 
     def swap(self, v):
-        r"""swap(vector_pvacuum_double_t self, vector_pvacuum_double_t v)"""
-        return _libBornAgainBase.vector_pvacuum_double_t_swap(self, v)
+        r"""swap(vector_pvacuum_double_T self, vector_pvacuum_double_T v)"""
+        return _libBornAgainBase.vector_pvacuum_double_T_swap(self, v)
 
     def begin(self):
-        r"""begin(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::iterator"""
-        return _libBornAgainBase.vector_pvacuum_double_t_begin(self)
+        r"""begin(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::iterator"""
+        return _libBornAgainBase.vector_pvacuum_double_T_begin(self)
 
     def end(self):
-        r"""end(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::iterator"""
-        return _libBornAgainBase.vector_pvacuum_double_t_end(self)
+        r"""end(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::iterator"""
+        return _libBornAgainBase.vector_pvacuum_double_T_end(self)
 
     def rbegin(self):
-        r"""rbegin(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::reverse_iterator"""
-        return _libBornAgainBase.vector_pvacuum_double_t_rbegin(self)
+        r"""rbegin(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::reverse_iterator"""
+        return _libBornAgainBase.vector_pvacuum_double_T_rbegin(self)
 
     def rend(self):
-        r"""rend(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::reverse_iterator"""
-        return _libBornAgainBase.vector_pvacuum_double_t_rend(self)
+        r"""rend(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::reverse_iterator"""
+        return _libBornAgainBase.vector_pvacuum_double_T_rend(self)
 
     def clear(self):
-        r"""clear(vector_pvacuum_double_t self)"""
-        return _libBornAgainBase.vector_pvacuum_double_t_clear(self)
+        r"""clear(vector_pvacuum_double_T self)"""
+        return _libBornAgainBase.vector_pvacuum_double_T_clear(self)
 
     def get_allocator(self):
-        r"""get_allocator(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::allocator_type"""
-        return _libBornAgainBase.vector_pvacuum_double_t_get_allocator(self)
+        r"""get_allocator(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::allocator_type"""
+        return _libBornAgainBase.vector_pvacuum_double_T_get_allocator(self)
 
     def pop_back(self):
-        r"""pop_back(vector_pvacuum_double_t self)"""
-        return _libBornAgainBase.vector_pvacuum_double_t_pop_back(self)
+        r"""pop_back(vector_pvacuum_double_T self)"""
+        return _libBornAgainBase.vector_pvacuum_double_T_pop_back(self)
 
     def erase(self, *args):
         r"""
-        erase(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::iterator pos) -> std::vector< std::pair< double,double > >::iterator
-        erase(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::iterator first, std::vector< std::pair< double,double > >::iterator last) -> std::vector< std::pair< double,double > >::iterator
+        erase(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::iterator pos) -> std::vector< std::pair< double,double > >::iterator
+        erase(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::iterator first, std::vector< std::pair< double,double > >::iterator last) -> std::vector< std::pair< double,double > >::iterator
         """
-        return _libBornAgainBase.vector_pvacuum_double_t_erase(self, *args)
+        return _libBornAgainBase.vector_pvacuum_double_T_erase(self, *args)
 
     def __init__(self, *args):
         r"""
-        __init__(vector_pvacuum_double_t self) -> vector_pvacuum_double_t
-        __init__(vector_pvacuum_double_t self, vector_pvacuum_double_t other) -> vector_pvacuum_double_t
-        __init__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::size_type size) -> vector_pvacuum_double_t
-        __init__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::size_type size, pvacuum_double_t value) -> vector_pvacuum_double_t
+        __init__(vector_pvacuum_double_T self) -> vector_pvacuum_double_T
+        __init__(vector_pvacuum_double_T self, vector_pvacuum_double_T other) -> vector_pvacuum_double_T
+        __init__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::size_type size) -> vector_pvacuum_double_T
+        __init__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::size_type size, pvacuum_double_T value) -> vector_pvacuum_double_T
         """
-        _libBornAgainBase.vector_pvacuum_double_t_swiginit(self, _libBornAgainBase.new_vector_pvacuum_double_t(*args))
+        _libBornAgainBase.vector_pvacuum_double_T_swiginit(self, _libBornAgainBase.new_vector_pvacuum_double_T(*args))
 
     def push_back(self, x):
-        r"""push_back(vector_pvacuum_double_t self, pvacuum_double_t x)"""
-        return _libBornAgainBase.vector_pvacuum_double_t_push_back(self, x)
+        r"""push_back(vector_pvacuum_double_T self, pvacuum_double_T x)"""
+        return _libBornAgainBase.vector_pvacuum_double_T_push_back(self, x)
 
     def front(self):
-        r"""front(vector_pvacuum_double_t self) -> pvacuum_double_t"""
-        return _libBornAgainBase.vector_pvacuum_double_t_front(self)
+        r"""front(vector_pvacuum_double_T self) -> pvacuum_double_T"""
+        return _libBornAgainBase.vector_pvacuum_double_T_front(self)
 
     def back(self):
-        r"""back(vector_pvacuum_double_t self) -> pvacuum_double_t"""
-        return _libBornAgainBase.vector_pvacuum_double_t_back(self)
+        r"""back(vector_pvacuum_double_T self) -> pvacuum_double_T"""
+        return _libBornAgainBase.vector_pvacuum_double_T_back(self)
 
     def assign(self, n, x):
-        r"""assign(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::size_type n, pvacuum_double_t x)"""
-        return _libBornAgainBase.vector_pvacuum_double_t_assign(self, n, x)
+        r"""assign(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::size_type n, pvacuum_double_T x)"""
+        return _libBornAgainBase.vector_pvacuum_double_T_assign(self, n, x)
 
     def resize(self, *args):
         r"""
-        resize(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::size_type new_size)
-        resize(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::size_type new_size, pvacuum_double_t x)
+        resize(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::size_type new_size)
+        resize(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::size_type new_size, pvacuum_double_T x)
         """
-        return _libBornAgainBase.vector_pvacuum_double_t_resize(self, *args)
+        return _libBornAgainBase.vector_pvacuum_double_T_resize(self, *args)
 
     def insert(self, *args):
         r"""
-        insert(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::iterator pos, pvacuum_double_t x) -> std::vector< std::pair< double,double > >::iterator
-        insert(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::iterator pos, std::vector< std::pair< double,double > >::size_type n, pvacuum_double_t x)
+        insert(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::iterator pos, pvacuum_double_T x) -> std::vector< std::pair< double,double > >::iterator
+        insert(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::iterator pos, std::vector< std::pair< double,double > >::size_type n, pvacuum_double_T x)
         """
-        return _libBornAgainBase.vector_pvacuum_double_t_insert(self, *args)
+        return _libBornAgainBase.vector_pvacuum_double_T_insert(self, *args)
 
     def reserve(self, n):
-        r"""reserve(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::size_type n)"""
-        return _libBornAgainBase.vector_pvacuum_double_t_reserve(self, n)
+        r"""reserve(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::size_type n)"""
+        return _libBornAgainBase.vector_pvacuum_double_T_reserve(self, n)
 
     def capacity(self):
-        r"""capacity(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::size_type"""
-        return _libBornAgainBase.vector_pvacuum_double_t_capacity(self)
-    __swig_destroy__ = _libBornAgainBase.delete_vector_pvacuum_double_t
+        r"""capacity(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::size_type"""
+        return _libBornAgainBase.vector_pvacuum_double_T_capacity(self)
+    __swig_destroy__ = _libBornAgainBase.delete_vector_pvacuum_double_T
 
-# Register vector_pvacuum_double_t in _libBornAgainBase:
-_libBornAgainBase.vector_pvacuum_double_t_swigregister(vector_pvacuum_double_t)
+# Register vector_pvacuum_double_T in _libBornAgainBase:
+_libBornAgainBase.vector_pvacuum_double_T_swigregister(vector_pvacuum_double_T)
 
 def mul_I(z):
     r"""mul_I(complex_t z) -> complex_t"""
@@ -1729,7 +1729,7 @@ class Span(object):
         return _libBornAgainBase.Span_contains(self, z)
 
     def pair(self):
-        r"""pair(Span self) -> pvacuum_double_t"""
+        r"""pair(Span self) -> pvacuum_double_T"""
         return _libBornAgainBase.Span_pair(self)
 
     @staticmethod
@@ -1806,7 +1806,7 @@ class Scale(object):
         return _libBornAgainBase.Scale_max(self)
 
     def bounds(self):
-        r"""bounds(Scale self) -> pvacuum_double_t"""
+        r"""bounds(Scale self) -> pvacuum_double_T"""
         return _libBornAgainBase.Scale_bounds(self)
 
     def rangeComprises(self, value):
@@ -1834,7 +1834,7 @@ class Scale(object):
         return _libBornAgainBase.Scale_bins(self)
 
     def binCenters(self):
-        r"""binCenters(Scale self) -> vdouble1d_t"""
+        r"""binCenters(Scale self) -> vdouble1d_T"""
         return _libBornAgainBase.Scale_binCenters(self)
 
     def closestIndex(self, value):
@@ -1856,7 +1856,7 @@ class Scale(object):
     def clipped(self, *args):
         r"""
         clipped(Scale self, double lower, double upper) -> Scale
-        clipped(Scale self, pvacuum_double_t bounds) -> Scale
+        clipped(Scale self, pvacuum_double_T bounds) -> Scale
         """
         return _libBornAgainBase.Scale_clipped(self, *args)
 
@@ -1912,11 +1912,11 @@ gauss = cvar.gauss
 
 
 def GenericScale(name, limits):
-    r"""GenericScale(std::string name, vdouble1d_t limits) -> Scale"""
+    r"""GenericScale(std::string name, vdouble1d_T limits) -> Scale"""
     return _libBornAgainBase.GenericScale(name, limits)
 
 def ListScan(name, points):
-    r"""ListScan(std::string name, vdouble1d_t points) -> Scale"""
+    r"""ListScan(std::string name, vdouble1d_T points) -> Scale"""
     return _libBornAgainBase.ListScan(name, points)
 
 def EquiDivision(name, N, start, end):
@@ -1979,7 +1979,7 @@ class Frame(object):
         return _libBornAgainBase.Frame_projectedBin(self, i_flat, k_axis)
 
     def allIndices(self, i_flat):
-        r"""allIndices(Frame self, size_t i_flat) -> vector_integer_t"""
+        r"""allIndices(Frame self, size_t i_flat) -> vector_integer_T"""
         return _libBornAgainBase.Frame_allIndices(self, i_flat)
 
     def projectedIndex(self, i, k_axis):
diff --git a/auto/Wrap/libBornAgainBase_wrap.cpp b/auto/Wrap/libBornAgainBase_wrap.cpp
index aa691259a54938880f3f297f06f559bf8070e184..7e14799f4bc3f327a827c67787cdace7b71dc10a 100644
--- a/auto/Wrap/libBornAgainBase_wrap.cpp
+++ b/auto/Wrap/libBornAgainBase_wrap.cpp
@@ -7879,7 +7879,7 @@ SWIGINTERN PyObject *SwigPyIterator_swigregister(PyObject *SWIGUNUSEDPARM(self),
   return SWIG_Py_Void();
 }
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_iterator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_iterator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   PyObject **arg2 = (PyObject **) 0 ;
@@ -7894,7 +7894,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_iterator(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_iterator" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_iterator" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = (swig::SwigPyIterator *)std_vector_Sl_double_Sg__iterator(arg1,arg2);
@@ -7905,7 +7905,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___nonzero__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___nonzero__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -7918,7 +7918,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___nonzero__(PyObject *self, PyObject *arg
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___nonzero__" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___nonzero__" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = (bool)std_vector_Sl_double_Sg____nonzero__((std::vector< double > const *)arg1);
@@ -7929,7 +7929,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___bool__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___bool__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -7942,7 +7942,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___bool__(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___bool__" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___bool__" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = (bool)std_vector_Sl_double_Sg____bool__((std::vector< double > const *)arg1);
@@ -7953,7 +7953,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___len__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___len__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -7966,7 +7966,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___len__(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___len__" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___len__" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = std_vector_Sl_double_Sg____len__((std::vector< double > const *)arg1);
@@ -7977,7 +7977,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___getslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___getslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::difference_type arg2 ;
@@ -7992,20 +7992,20 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___getslice__(PyObject *self, PyObject *ar
   std::vector< double,std::allocator< double > > *result = 0 ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_t___getslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_T___getslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___getslice__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___getslice__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t___getslice__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T___getslice__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< double >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_t___getslice__" "', argument " "3"" of type '" "std::vector< double >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_T___getslice__" "', argument " "3"" of type '" "std::vector< double >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< double >::difference_type >(val3);
   try {
@@ -8022,7 +8022,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::difference_type arg2 ;
@@ -8038,17 +8038,17 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setslice____SWIG_0(PyObject *self, Py_s
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___setslice__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___setslice__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t___setslice__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T___setslice__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< double >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_t___setslice__" "', argument " "3"" of type '" "std::vector< double >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_T___setslice__" "', argument " "3"" of type '" "std::vector< double >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< double >::difference_type >(val3);
   try {
@@ -8065,7 +8065,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::difference_type arg2 ;
@@ -8083,27 +8083,27 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setslice____SWIG_1(PyObject *self, Py_s
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___setslice__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___setslice__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t___setslice__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T___setslice__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< double >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_t___setslice__" "', argument " "3"" of type '" "std::vector< double >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_T___setslice__" "', argument " "3"" of type '" "std::vector< double >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< double >::difference_type >(val3);
   {
     std::vector< double,std::allocator< double > > *ptr = (std::vector< double,std::allocator< double > > *)0;
     res4 = swig::asptr(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vdouble1d_t___setslice__" "', argument " "4"" of type '" "std::vector< double,std::allocator< double > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vdouble1d_T___setslice__" "', argument " "4"" of type '" "std::vector< double,std::allocator< double > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble1d_t___setslice__" "', argument " "4"" of type '" "std::vector< double,std::allocator< double > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble1d_T___setslice__" "', argument " "4"" of type '" "std::vector< double,std::allocator< double > > const &""'"); 
     }
     arg4 = ptr;
   }
@@ -8123,13 +8123,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___setslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___setslice__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_t___setslice__", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_T___setslice__", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -8146,7 +8146,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setslice__(PyObject *self, PyObject *ar
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vdouble1d_t___setslice____SWIG_0(self, argc, argv);
+          return _wrap_vdouble1d_T___setslice____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -8169,7 +8169,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setslice__(PyObject *self, PyObject *ar
           int res = swig::asptr(argv[3], (std::vector< double,std::allocator< double > >**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vdouble1d_t___setslice____SWIG_1(self, argc, argv);
+            return _wrap_vdouble1d_T___setslice____SWIG_1(self, argc, argv);
           }
         }
       }
@@ -8177,7 +8177,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setslice__(PyObject *self, PyObject *ar
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_t___setslice__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_T___setslice__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< double >::__setslice__(std::vector< double >::difference_type,std::vector< double >::difference_type)\n"
     "    std::vector< double >::__setslice__(std::vector< double >::difference_type,std::vector< double >::difference_type,std::vector< double,std::allocator< double > > const &)\n");
@@ -8185,7 +8185,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___delslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___delslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::difference_type arg2 ;
@@ -8199,20 +8199,20 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___delslice__(PyObject *self, PyObject *ar
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_t___delslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_T___delslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___delslice__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___delslice__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t___delslice__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T___delslice__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< double >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_t___delslice__" "', argument " "3"" of type '" "std::vector< double >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_T___delslice__" "', argument " "3"" of type '" "std::vector< double >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< double >::difference_type >(val3);
   try {
@@ -8229,7 +8229,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::difference_type arg2 ;
@@ -8242,12 +8242,12 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___delitem____SWIG_0(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___delitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___delitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t___delitem__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T___delitem__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< double >::difference_type >(val2);
   try {
@@ -8264,7 +8264,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -8276,12 +8276,12 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___getitem____SWIG_0(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___getitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___getitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -8299,7 +8299,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -8312,12 +8312,12 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setitem____SWIG_0(PyObject *self, Py_ss
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___setitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___setitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -8325,10 +8325,10 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setitem____SWIG_0(PyObject *self, Py_ss
     std::vector< double,std::allocator< double > > *ptr = (std::vector< double,std::allocator< double > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble1d_t___setitem__" "', argument " "3"" of type '" "std::vector< double,std::allocator< double > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble1d_T___setitem__" "', argument " "3"" of type '" "std::vector< double,std::allocator< double > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble1d_t___setitem__" "', argument " "3"" of type '" "std::vector< double,std::allocator< double > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble1d_T___setitem__" "', argument " "3"" of type '" "std::vector< double,std::allocator< double > > const &""'"); 
     }
     arg3 = ptr;
   }
@@ -8348,7 +8348,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -8359,12 +8359,12 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setitem____SWIG_1(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___setitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___setitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -8382,7 +8382,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -8393,12 +8393,12 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___delitem____SWIG_1(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___delitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___delitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -8416,13 +8416,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___delitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___delitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_t___delitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_T___delitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -8433,7 +8433,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___delitem__(PyObject *self, PyObject *arg
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vdouble1d_t___delitem____SWIG_1(self, argc, argv);
+        return _wrap_vdouble1d_T___delitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -8447,13 +8447,13 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___delitem__(PyObject *self, PyObject *arg
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vdouble1d_t___delitem____SWIG_0(self, argc, argv);
+        return _wrap_vdouble1d_T___delitem____SWIG_0(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_t___delitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_T___delitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< double >::__delitem__(std::vector< double >::difference_type)\n"
     "    std::vector< double >::__delitem__(SWIGPY_SLICEOBJECT *)\n");
@@ -8461,7 +8461,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::difference_type arg2 ;
@@ -8475,12 +8475,12 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___getitem____SWIG_1(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___getitem__" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___getitem__" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t___getitem__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T___getitem__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< double >::difference_type >(val2);
   try {
@@ -8496,13 +8496,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___getitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___getitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_t___getitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_T___getitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -8513,7 +8513,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___getitem__(PyObject *self, PyObject *arg
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vdouble1d_t___getitem____SWIG_0(self, argc, argv);
+        return _wrap_vdouble1d_T___getitem____SWIG_0(self, argc, argv);
       }
     }
   }
@@ -8527,13 +8527,13 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___getitem__(PyObject *self, PyObject *arg
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vdouble1d_t___getitem____SWIG_1(self, argc, argv);
+        return _wrap_vdouble1d_T___getitem____SWIG_1(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_t___getitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_T___getitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< double >::__getitem__(SWIGPY_SLICEOBJECT *)\n"
     "    std::vector< double >::__getitem__(std::vector< double >::difference_type) const\n");
@@ -8541,7 +8541,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::difference_type arg2 ;
@@ -8558,17 +8558,17 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setitem____SWIG_2(PyObject *self, Py_ss
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___setitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___setitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t___setitem__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T___setitem__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< double >::difference_type >(val2);
   ecode3 = SWIG_AsVal_double(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_t___setitem__" "', argument " "3"" of type '" "std::vector< double >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_T___setitem__" "', argument " "3"" of type '" "std::vector< double >::value_type""'");
   } 
   temp3 = static_cast< std::vector< double >::value_type >(val3);
   arg3 = &temp3;
@@ -8584,13 +8584,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___setitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___setitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_t___setitem__", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_T___setitem__", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -8601,7 +8601,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setitem__(PyObject *self, PyObject *arg
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vdouble1d_t___setitem____SWIG_1(self, argc, argv);
+        return _wrap_vdouble1d_T___setitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -8617,7 +8617,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setitem__(PyObject *self, PyObject *arg
         int res = swig::asptr(argv[2], (std::vector< double,std::allocator< double > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vdouble1d_t___setitem____SWIG_0(self, argc, argv);
+          return _wrap_vdouble1d_T___setitem____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -8637,14 +8637,14 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setitem__(PyObject *self, PyObject *arg
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vdouble1d_t___setitem____SWIG_2(self, argc, argv);
+          return _wrap_vdouble1d_T___setitem____SWIG_2(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_t___setitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_T___setitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< double >::__setitem__(SWIGPY_SLICEOBJECT *,std::vector< double,std::allocator< double > > const &)\n"
     "    std::vector< double >::__setitem__(SWIGPY_SLICEOBJECT *)\n"
@@ -8653,7 +8653,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_pop(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_pop(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -8666,7 +8666,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_pop(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_pop" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_pop" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   try {
@@ -8681,7 +8681,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_append(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_append(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::value_type *arg2 = 0 ;
@@ -8693,15 +8693,15 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_append(PyObject *self, PyObject *args) {
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_t_append", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_T_append", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_append" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_append" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_double(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t_append" "', argument " "2"" of type '" "std::vector< double >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T_append" "', argument " "2"" of type '" "std::vector< double >::value_type""'");
   } 
   temp2 = static_cast< std::vector< double >::value_type >(val2);
   arg2 = &temp2;
@@ -8713,7 +8713,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vdouble1d_t__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
+SWIGINTERN PyObject *_wrap_new_vdouble1d_T__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
   PyObject *resultobj = 0;
   std::vector< double > *result = 0 ;
   
@@ -8727,7 +8727,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vdouble1d_t__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vdouble1d_T__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = 0 ;
   int res1 = SWIG_OLDOBJ ;
@@ -8739,10 +8739,10 @@ SWIGINTERN PyObject *_wrap_new_vdouble1d_t__SWIG_1(PyObject *self, Py_ssize_t no
     std::vector< double,std::allocator< double > > *ptr = (std::vector< double,std::allocator< double > > *)0;
     res1 = swig::asptr(swig_obj[0], &ptr);
     if (!SWIG_IsOK(res1)) {
-      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vdouble1d_t" "', argument " "1"" of type '" "std::vector< double > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vdouble1d_T" "', argument " "1"" of type '" "std::vector< double > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vdouble1d_t" "', argument " "1"" of type '" "std::vector< double > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vdouble1d_T" "', argument " "1"" of type '" "std::vector< double > const &""'"); 
     }
     arg1 = ptr;
   }
@@ -8756,7 +8756,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_empty(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_empty(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -8769,7 +8769,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_empty(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_empty" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_empty" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = (bool)((std::vector< double > const *)arg1)->empty();
@@ -8780,7 +8780,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_size(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_size(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -8793,7 +8793,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_size(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_size" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_size" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = ((std::vector< double > const *)arg1)->size();
@@ -8804,7 +8804,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_swap(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_swap(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double > *arg2 = 0 ;
@@ -8815,18 +8815,18 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_swap(PyObject *self, PyObject *args) {
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_t_swap", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_T_swap", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_swap" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_swap" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], &argp2, SWIGTYPE_p_std__vectorT_double_t,  0 );
   if (!SWIG_IsOK(res2)) {
-    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vdouble1d_t_swap" "', argument " "2"" of type '" "std::vector< double > &""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vdouble1d_T_swap" "', argument " "2"" of type '" "std::vector< double > &""'"); 
   }
   if (!argp2) {
-    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble1d_t_swap" "', argument " "2"" of type '" "std::vector< double > &""'"); 
+    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble1d_T_swap" "', argument " "2"" of type '" "std::vector< double > &""'"); 
   }
   arg2 = reinterpret_cast< std::vector< double > * >(argp2);
   (arg1)->swap(*arg2);
@@ -8837,7 +8837,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_begin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_begin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -8850,7 +8850,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_begin(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_begin" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_begin" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = (arg1)->begin();
@@ -8862,7 +8862,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_end(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_end(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -8875,7 +8875,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_end(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_end" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_end" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = (arg1)->end();
@@ -8887,7 +8887,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_rbegin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_rbegin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -8900,7 +8900,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_rbegin(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_rbegin" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_rbegin" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = (arg1)->rbegin();
@@ -8912,7 +8912,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_rend(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_rend(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -8925,7 +8925,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_rend(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_rend" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_rend" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = (arg1)->rend();
@@ -8937,7 +8937,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_clear(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_clear(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -8949,7 +8949,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_clear(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_clear" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_clear" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   (arg1)->clear();
@@ -8960,7 +8960,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_get_allocator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_get_allocator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -8973,7 +8973,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_get_allocator(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_get_allocator" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_get_allocator" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = ((std::vector< double > const *)arg1)->get_allocator();
@@ -8984,7 +8984,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vdouble1d_t__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vdouble1d_T__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double >::size_type arg1 ;
   size_t val1 ;
@@ -8995,7 +8995,7 @@ SWIGINTERN PyObject *_wrap_new_vdouble1d_t__SWIG_2(PyObject *self, Py_ssize_t no
   if ((nobjs < 1) || (nobjs > 1)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vdouble1d_t" "', argument " "1"" of type '" "std::vector< double >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vdouble1d_T" "', argument " "1"" of type '" "std::vector< double >::size_type""'");
   } 
   arg1 = static_cast< std::vector< double >::size_type >(val1);
   result = (std::vector< double > *)new std::vector< double >(arg1);
@@ -9006,7 +9006,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_pop_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_pop_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -9018,7 +9018,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_pop_back(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_pop_back" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_pop_back" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   (arg1)->pop_back();
@@ -9029,7 +9029,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::size_type arg2 ;
@@ -9042,12 +9042,12 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_resize__SWIG_0(PyObject *self, Py_ssize_t
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_resize" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_resize" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t_resize" "', argument " "2"" of type '" "std::vector< double >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T_resize" "', argument " "2"" of type '" "std::vector< double >::size_type""'");
   } 
   arg2 = static_cast< std::vector< double >::size_type >(val2);
   (arg1)->resize(arg2);
@@ -9058,7 +9058,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::iterator arg2 ;
@@ -9072,18 +9072,18 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_erase__SWIG_0(PyObject *self, Py_ssize_t
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_erase" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_erase" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t_erase" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T_erase" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< double >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< double >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t_erase" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T_erase" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
     }
   }
   result = std_vector_Sl_double_Sg__erase__SWIG_0(arg1,SWIG_STD_MOVE(arg2));
@@ -9095,7 +9095,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::iterator arg2 ;
@@ -9112,29 +9112,29 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_erase__SWIG_1(PyObject *self, Py_ssize_t
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_erase" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_erase" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t_erase" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T_erase" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< double >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< double >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t_erase" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T_erase" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
     }
   }
   res3 = SWIG_ConvertPtr(swig_obj[2], SWIG_as_voidptrptr(&iter3), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res3) || !iter3) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t_erase" "', argument " "3"" of type '" "std::vector< double >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T_erase" "', argument " "3"" of type '" "std::vector< double >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< double >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< double >::iterator > *>(iter3);
     if (iter_t) {
       arg3 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t_erase" "', argument " "3"" of type '" "std::vector< double >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T_erase" "', argument " "3"" of type '" "std::vector< double >::iterator""'");
     }
   }
   result = std_vector_Sl_double_Sg__erase__SWIG_1(arg1,SWIG_STD_MOVE(arg2),SWIG_STD_MOVE(arg3));
@@ -9146,13 +9146,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_erase(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_erase(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_t_erase", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_T_erase", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -9163,7 +9163,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_erase(PyObject *self, PyObject *args) {
       int res = SWIG_ConvertPtr(argv[1], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
       _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< double >::iterator > *>(iter) != 0));
       if (_v) {
-        return _wrap_vdouble1d_t_erase__SWIG_0(self, argc, argv);
+        return _wrap_vdouble1d_T_erase__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -9180,14 +9180,14 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_erase(PyObject *self, PyObject *args) {
         int res = SWIG_ConvertPtr(argv[2], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
         _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< double >::iterator > *>(iter) != 0));
         if (_v) {
-          return _wrap_vdouble1d_t_erase__SWIG_1(self, argc, argv);
+          return _wrap_vdouble1d_T_erase__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_t_erase'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_T_erase'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< double >::erase(std::vector< double >::iterator)\n"
     "    std::vector< double >::erase(std::vector< double >::iterator,std::vector< double >::iterator)\n");
@@ -9195,7 +9195,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vdouble1d_t__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vdouble1d_T__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double >::size_type arg1 ;
   std::vector< double >::value_type *arg2 = 0 ;
@@ -9210,12 +9210,12 @@ SWIGINTERN PyObject *_wrap_new_vdouble1d_t__SWIG_3(PyObject *self, Py_ssize_t no
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vdouble1d_t" "', argument " "1"" of type '" "std::vector< double >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vdouble1d_T" "', argument " "1"" of type '" "std::vector< double >::size_type""'");
   } 
   arg1 = static_cast< std::vector< double >::size_type >(val1);
   ecode2 = SWIG_AsVal_double(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "new_vdouble1d_t" "', argument " "2"" of type '" "std::vector< double >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "new_vdouble1d_T" "', argument " "2"" of type '" "std::vector< double >::value_type""'");
   } 
   temp2 = static_cast< std::vector< double >::value_type >(val2);
   arg2 = &temp2;
@@ -9227,16 +9227,16 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vdouble1d_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_new_vdouble1d_T(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vdouble1d_t", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vdouble1d_T", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 0) {
-    return _wrap_new_vdouble1d_t__SWIG_0(self, argc, argv);
+    return _wrap_new_vdouble1d_T__SWIG_0(self, argc, argv);
   }
   if (argc == 1) {
     int _v = 0;
@@ -9245,7 +9245,7 @@ SWIGINTERN PyObject *_wrap_new_vdouble1d_t(PyObject *self, PyObject *args) {
       _v = SWIG_CheckState(res);
     }
     if (_v) {
-      return _wrap_new_vdouble1d_t__SWIG_2(self, argc, argv);
+      return _wrap_new_vdouble1d_T__SWIG_2(self, argc, argv);
     }
   }
   if (argc == 1) {
@@ -9253,7 +9253,7 @@ SWIGINTERN PyObject *_wrap_new_vdouble1d_t(PyObject *self, PyObject *args) {
     int res = swig::asptr(argv[0], (std::vector< double,std::allocator< double > >**)(0));
     _v = SWIG_CheckState(res);
     if (_v) {
-      return _wrap_new_vdouble1d_t__SWIG_1(self, argc, argv);
+      return _wrap_new_vdouble1d_T__SWIG_1(self, argc, argv);
     }
   }
   if (argc == 2) {
@@ -9268,13 +9268,13 @@ SWIGINTERN PyObject *_wrap_new_vdouble1d_t(PyObject *self, PyObject *args) {
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_new_vdouble1d_t__SWIG_3(self, argc, argv);
+        return _wrap_new_vdouble1d_T__SWIG_3(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vdouble1d_t'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vdouble1d_T'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< double >::vector()\n"
     "    std::vector< double >::vector(std::vector< double > const &)\n"
@@ -9284,7 +9284,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_push_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_push_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::value_type *arg2 = 0 ;
@@ -9296,15 +9296,15 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_push_back(PyObject *self, PyObject *args)
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_t_push_back", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_T_push_back", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_push_back" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_push_back" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_double(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t_push_back" "', argument " "2"" of type '" "std::vector< double >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T_push_back" "', argument " "2"" of type '" "std::vector< double >::value_type""'");
   } 
   temp2 = static_cast< std::vector< double >::value_type >(val2);
   arg2 = &temp2;
@@ -9316,7 +9316,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_front(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_front(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -9329,7 +9329,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_front(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_front" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_front" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = (std::vector< double >::value_type *) &((std::vector< double > const *)arg1)->front();
@@ -9341,7 +9341,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -9354,7 +9354,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_back(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_back" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_back" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = (std::vector< double >::value_type *) &((std::vector< double > const *)arg1)->back();
@@ -9366,7 +9366,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_assign(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_assign(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::size_type arg2 ;
@@ -9381,20 +9381,20 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_assign(PyObject *self, PyObject *args) {
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_t_assign", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_T_assign", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_assign" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_assign" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t_assign" "', argument " "2"" of type '" "std::vector< double >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T_assign" "', argument " "2"" of type '" "std::vector< double >::size_type""'");
   } 
   arg2 = static_cast< std::vector< double >::size_type >(val2);
   ecode3 = SWIG_AsVal_double(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_t_assign" "', argument " "3"" of type '" "std::vector< double >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_T_assign" "', argument " "3"" of type '" "std::vector< double >::value_type""'");
   } 
   temp3 = static_cast< std::vector< double >::value_type >(val3);
   arg3 = &temp3;
@@ -9406,7 +9406,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::size_type arg2 ;
@@ -9423,17 +9423,17 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_resize__SWIG_1(PyObject *self, Py_ssize_t
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_resize" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_resize" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t_resize" "', argument " "2"" of type '" "std::vector< double >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T_resize" "', argument " "2"" of type '" "std::vector< double >::size_type""'");
   } 
   arg2 = static_cast< std::vector< double >::size_type >(val2);
   ecode3 = SWIG_AsVal_double(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_t_resize" "', argument " "3"" of type '" "std::vector< double >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_T_resize" "', argument " "3"" of type '" "std::vector< double >::value_type""'");
   } 
   temp3 = static_cast< std::vector< double >::value_type >(val3);
   arg3 = &temp3;
@@ -9445,13 +9445,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_resize(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_resize(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_t_resize", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_T_resize", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -9463,7 +9463,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_resize(PyObject *self, PyObject *args) {
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vdouble1d_t_resize__SWIG_0(self, argc, argv);
+        return _wrap_vdouble1d_T_resize__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -9482,14 +9482,14 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_resize(PyObject *self, PyObject *args) {
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vdouble1d_t_resize__SWIG_1(self, argc, argv);
+          return _wrap_vdouble1d_T_resize__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_t_resize'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_T_resize'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< double >::resize(std::vector< double >::size_type)\n"
     "    std::vector< double >::resize(std::vector< double >::size_type,std::vector< double >::value_type const &)\n");
@@ -9497,7 +9497,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::iterator arg2 ;
@@ -9515,23 +9515,23 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_insert__SWIG_0(PyObject *self, Py_ssize_t
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_insert" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_insert" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t_insert" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T_insert" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< double >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< double >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t_insert" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T_insert" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_double(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_t_insert" "', argument " "3"" of type '" "std::vector< double >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_T_insert" "', argument " "3"" of type '" "std::vector< double >::value_type""'");
   } 
   temp3 = static_cast< std::vector< double >::value_type >(val3);
   arg3 = &temp3;
@@ -9544,7 +9544,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::iterator arg2 ;
@@ -9564,28 +9564,28 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_insert__SWIG_1(PyObject *self, Py_ssize_t
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_insert" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_insert" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t_insert" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T_insert" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< double >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< double >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t_insert" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T_insert" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_size_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_t_insert" "', argument " "3"" of type '" "std::vector< double >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_T_insert" "', argument " "3"" of type '" "std::vector< double >::size_type""'");
   } 
   arg3 = static_cast< std::vector< double >::size_type >(val3);
   ecode4 = SWIG_AsVal_double(swig_obj[3], &val4);
   if (!SWIG_IsOK(ecode4)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode4), "in method '" "vdouble1d_t_insert" "', argument " "4"" of type '" "std::vector< double >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode4), "in method '" "vdouble1d_T_insert" "', argument " "4"" of type '" "std::vector< double >::value_type""'");
   } 
   temp4 = static_cast< std::vector< double >::value_type >(val4);
   arg4 = &temp4;
@@ -9597,13 +9597,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_insert(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_insert(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_t_insert", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_T_insert", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -9619,7 +9619,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_insert(PyObject *self, PyObject *args) {
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vdouble1d_t_insert__SWIG_0(self, argc, argv);
+          return _wrap_vdouble1d_T_insert__SWIG_0(self, argc, argv);
         }
       }
     }
@@ -9643,7 +9643,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_insert(PyObject *self, PyObject *args) {
             _v = SWIG_CheckState(res);
           }
           if (_v) {
-            return _wrap_vdouble1d_t_insert__SWIG_1(self, argc, argv);
+            return _wrap_vdouble1d_T_insert__SWIG_1(self, argc, argv);
           }
         }
       }
@@ -9651,7 +9651,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_insert(PyObject *self, PyObject *args) {
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_t_insert'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_T_insert'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< double >::insert(std::vector< double >::iterator,std::vector< double >::value_type const &)\n"
     "    std::vector< double >::insert(std::vector< double >::iterator,std::vector< double >::size_type,std::vector< double >::value_type const &)\n");
@@ -9659,7 +9659,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_reserve(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_reserve(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::size_type arg2 ;
@@ -9670,15 +9670,15 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_reserve(PyObject *self, PyObject *args) {
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_t_reserve", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_T_reserve", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_reserve" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_reserve" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t_reserve" "', argument " "2"" of type '" "std::vector< double >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T_reserve" "', argument " "2"" of type '" "std::vector< double >::size_type""'");
   } 
   arg2 = static_cast< std::vector< double >::size_type >(val2);
   (arg1)->reserve(arg2);
@@ -9689,7 +9689,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_capacity(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_capacity(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -9702,7 +9702,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_capacity(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_capacity" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_capacity" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = ((std::vector< double > const *)arg1)->capacity();
@@ -9713,7 +9713,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_delete_vdouble1d_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_delete_vdouble1d_T(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -9725,7 +9725,7 @@ SWIGINTERN PyObject *_wrap_delete_vdouble1d_t(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, SWIG_POINTER_DISOWN |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vdouble1d_t" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vdouble1d_T" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   {
@@ -9746,18 +9746,18 @@ fail:
 }
 
 
-SWIGINTERN PyObject *vdouble1d_t_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vdouble1d_T_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   PyObject *obj;
   if (!SWIG_Python_UnpackTuple(args, "swigregister", 1, 1, &obj)) return NULL;
   SWIG_TypeNewClientData(SWIGTYPE_p_std__vectorT_double_t, SWIG_NewClientData(obj));
   return SWIG_Py_Void();
 }
 
-SWIGINTERN PyObject *vdouble1d_t_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vdouble1d_T_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   return SWIG_Python_InitShadowInstance(args);
 }
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_iterator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_iterator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   PyObject **arg2 = (PyObject **) 0 ;
@@ -9772,7 +9772,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_iterator(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_iterator" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_iterator" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = (swig::SwigPyIterator *)std_vector_Sl_std_vector_Sl_double_Sg__Sg__iterator(arg1,arg2);
@@ -9783,7 +9783,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___nonzero__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___nonzero__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -9796,7 +9796,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___nonzero__(PyObject *self, PyObject *arg
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___nonzero__" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___nonzero__" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = (bool)std_vector_Sl_std_vector_Sl_double_Sg__Sg____nonzero__((std::vector< std::vector< double > > const *)arg1);
@@ -9807,7 +9807,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___bool__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___bool__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -9820,7 +9820,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___bool__(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___bool__" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___bool__" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = (bool)std_vector_Sl_std_vector_Sl_double_Sg__Sg____bool__((std::vector< std::vector< double > > const *)arg1);
@@ -9831,7 +9831,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___len__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___len__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -9844,7 +9844,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___len__(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___len__" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___len__" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = std_vector_Sl_std_vector_Sl_double_Sg__Sg____len__((std::vector< std::vector< double > > const *)arg1);
@@ -9855,7 +9855,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___getslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___getslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::difference_type arg2 ;
@@ -9870,20 +9870,20 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___getslice__(PyObject *self, PyObject *ar
   std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > *result = 0 ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_t___getslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_T___getslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___getslice__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___getslice__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_t___getslice__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_T___getslice__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble2d_t___getslice__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble2d_T___getslice__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::vector< double > >::difference_type >(val3);
   try {
@@ -9900,7 +9900,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::difference_type arg2 ;
@@ -9916,17 +9916,17 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setslice____SWIG_0(PyObject *self, Py_s
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___setslice__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___setslice__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_t___setslice__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_T___setslice__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble2d_t___setslice__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble2d_T___setslice__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::vector< double > >::difference_type >(val3);
   try {
@@ -9943,7 +9943,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::difference_type arg2 ;
@@ -9961,27 +9961,27 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setslice____SWIG_1(PyObject *self, Py_s
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___setslice__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___setslice__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_t___setslice__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_T___setslice__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble2d_t___setslice__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble2d_T___setslice__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::vector< double > >::difference_type >(val3);
   {
     std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > *ptr = (std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > *)0;
     res4 = swig::asptr(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vdouble2d_t___setslice__" "', argument " "4"" of type '" "std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vdouble2d_T___setslice__" "', argument " "4"" of type '" "std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_t___setslice__" "', argument " "4"" of type '" "std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_T___setslice__" "', argument " "4"" of type '" "std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > const &""'"); 
     }
     arg4 = ptr;
   }
@@ -10001,13 +10001,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___setslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___setslice__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_t___setslice__", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_T___setslice__", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -10024,7 +10024,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setslice__(PyObject *self, PyObject *ar
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vdouble2d_t___setslice____SWIG_0(self, argc, argv);
+          return _wrap_vdouble2d_T___setslice____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -10047,7 +10047,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setslice__(PyObject *self, PyObject *ar
           int res = swig::asptr(argv[3], (std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > >**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vdouble2d_t___setslice____SWIG_1(self, argc, argv);
+            return _wrap_vdouble2d_T___setslice____SWIG_1(self, argc, argv);
           }
         }
       }
@@ -10055,7 +10055,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setslice__(PyObject *self, PyObject *ar
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_t___setslice__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_T___setslice__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< double > >::__setslice__(std::vector< std::vector< double > >::difference_type,std::vector< std::vector< double > >::difference_type)\n"
     "    std::vector< std::vector< double > >::__setslice__(std::vector< std::vector< double > >::difference_type,std::vector< std::vector< double > >::difference_type,std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > const &)\n");
@@ -10063,7 +10063,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___delslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___delslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::difference_type arg2 ;
@@ -10077,20 +10077,20 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___delslice__(PyObject *self, PyObject *ar
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_t___delslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_T___delslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___delslice__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___delslice__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_t___delslice__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_T___delslice__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble2d_t___delslice__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble2d_T___delslice__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::vector< double > >::difference_type >(val3);
   try {
@@ -10107,7 +10107,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::difference_type arg2 ;
@@ -10120,12 +10120,12 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___delitem____SWIG_0(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___delitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___delitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_t___delitem__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_T___delitem__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< double > >::difference_type >(val2);
   try {
@@ -10142,7 +10142,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -10154,12 +10154,12 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___getitem____SWIG_0(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___getitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___getitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -10177,7 +10177,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -10190,12 +10190,12 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setitem____SWIG_0(PyObject *self, Py_ss
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -10203,10 +10203,10 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setitem____SWIG_0(PyObject *self, Py_ss
     std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > *ptr = (std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble2d_t___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble2d_T___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_t___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_T___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > const &""'"); 
     }
     arg3 = ptr;
   }
@@ -10226,7 +10226,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -10237,12 +10237,12 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setitem____SWIG_1(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -10260,7 +10260,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -10271,12 +10271,12 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___delitem____SWIG_1(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___delitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___delitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -10294,13 +10294,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___delitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___delitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_t___delitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_T___delitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -10311,7 +10311,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___delitem__(PyObject *self, PyObject *arg
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vdouble2d_t___delitem____SWIG_1(self, argc, argv);
+        return _wrap_vdouble2d_T___delitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -10325,13 +10325,13 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___delitem__(PyObject *self, PyObject *arg
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vdouble2d_t___delitem____SWIG_0(self, argc, argv);
+        return _wrap_vdouble2d_T___delitem____SWIG_0(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_t___delitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_T___delitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< double > >::__delitem__(std::vector< std::vector< double > >::difference_type)\n"
     "    std::vector< std::vector< double > >::__delitem__(SWIGPY_SLICEOBJECT *)\n");
@@ -10339,7 +10339,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::difference_type arg2 ;
@@ -10353,12 +10353,12 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___getitem____SWIG_1(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___getitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___getitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_t___getitem__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_T___getitem__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< double > >::difference_type >(val2);
   try {
@@ -10374,13 +10374,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___getitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___getitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_t___getitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_T___getitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -10391,7 +10391,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___getitem__(PyObject *self, PyObject *arg
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vdouble2d_t___getitem____SWIG_0(self, argc, argv);
+        return _wrap_vdouble2d_T___getitem____SWIG_0(self, argc, argv);
       }
     }
   }
@@ -10405,13 +10405,13 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___getitem__(PyObject *self, PyObject *arg
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vdouble2d_t___getitem____SWIG_1(self, argc, argv);
+        return _wrap_vdouble2d_T___getitem____SWIG_1(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_t___getitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_T___getitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< double > >::__getitem__(SWIGPY_SLICEOBJECT *)\n"
     "    std::vector< std::vector< double > >::__getitem__(std::vector< std::vector< double > >::difference_type) const\n");
@@ -10419,7 +10419,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::difference_type arg2 ;
@@ -10434,22 +10434,22 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setitem____SWIG_2(PyObject *self, Py_ss
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_t___setitem__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_T___setitem__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< double > >::difference_type >(val2);
   {
     std::vector< double,std::allocator< double > > *ptr = (std::vector< double,std::allocator< double > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble2d_t___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble2d_T___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_t___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_T___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -10467,13 +10467,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___setitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___setitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_t___setitem__", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_T___setitem__", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -10484,7 +10484,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setitem__(PyObject *self, PyObject *arg
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vdouble2d_t___setitem____SWIG_1(self, argc, argv);
+        return _wrap_vdouble2d_T___setitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -10500,7 +10500,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setitem__(PyObject *self, PyObject *arg
         int res = swig::asptr(argv[2], (std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vdouble2d_t___setitem____SWIG_0(self, argc, argv);
+          return _wrap_vdouble2d_T___setitem____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -10518,14 +10518,14 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setitem__(PyObject *self, PyObject *arg
         int res = swig::asptr(argv[2], (std::vector< double,std::allocator< double > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vdouble2d_t___setitem____SWIG_2(self, argc, argv);
+          return _wrap_vdouble2d_T___setitem____SWIG_2(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_t___setitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_T___setitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< double > >::__setitem__(SWIGPY_SLICEOBJECT *,std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > const &)\n"
     "    std::vector< std::vector< double > >::__setitem__(SWIGPY_SLICEOBJECT *)\n"
@@ -10534,7 +10534,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_pop(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_pop(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -10547,7 +10547,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_pop(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_pop" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_pop" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   try {
@@ -10562,7 +10562,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_append(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_append(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::value_type *arg2 = 0 ;
@@ -10572,20 +10572,20 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_append(PyObject *self, PyObject *args) {
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_t_append", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_T_append", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_append" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_append" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   {
     std::vector< double,std::allocator< double > > *ptr = (std::vector< double,std::allocator< double > > *)0;
     res2 = swig::asptr(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vdouble2d_t_append" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vdouble2d_T_append" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_t_append" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_T_append" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -10599,7 +10599,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vdouble2d_t__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
+SWIGINTERN PyObject *_wrap_new_vdouble2d_T__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *result = 0 ;
   
@@ -10613,7 +10613,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vdouble2d_t__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vdouble2d_T__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double,std::allocator< double > > > *arg1 = 0 ;
   int res1 = SWIG_OLDOBJ ;
@@ -10625,10 +10625,10 @@ SWIGINTERN PyObject *_wrap_new_vdouble2d_t__SWIG_1(PyObject *self, Py_ssize_t no
     std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > *ptr = (std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > *)0;
     res1 = swig::asptr(swig_obj[0], &ptr);
     if (!SWIG_IsOK(res1)) {
-      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vdouble2d_t" "', argument " "1"" of type '" "std::vector< std::vector< double,std::allocator< double > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vdouble2d_T" "', argument " "1"" of type '" "std::vector< std::vector< double,std::allocator< double > > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vdouble2d_t" "', argument " "1"" of type '" "std::vector< std::vector< double,std::allocator< double > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vdouble2d_T" "', argument " "1"" of type '" "std::vector< std::vector< double,std::allocator< double > > > const &""'"); 
     }
     arg1 = ptr;
   }
@@ -10642,7 +10642,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_empty(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_empty(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -10655,7 +10655,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_empty(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_empty" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_empty" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = (bool)((std::vector< std::vector< double > > const *)arg1)->empty();
@@ -10666,7 +10666,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_size(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_size(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -10679,7 +10679,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_size(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_size" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_size" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = ((std::vector< std::vector< double > > const *)arg1)->size();
@@ -10690,7 +10690,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_swap(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_swap(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double,std::allocator< double > > > *arg2 = 0 ;
@@ -10701,18 +10701,18 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_swap(PyObject *self, PyObject *args) {
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_t_swap", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_T_swap", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_swap" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_swap" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], &argp2, SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t,  0 );
   if (!SWIG_IsOK(res2)) {
-    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vdouble2d_t_swap" "', argument " "2"" of type '" "std::vector< std::vector< double,std::allocator< double > > > &""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vdouble2d_T_swap" "', argument " "2"" of type '" "std::vector< std::vector< double,std::allocator< double > > > &""'"); 
   }
   if (!argp2) {
-    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_t_swap" "', argument " "2"" of type '" "std::vector< std::vector< double,std::allocator< double > > > &""'"); 
+    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_T_swap" "', argument " "2"" of type '" "std::vector< std::vector< double,std::allocator< double > > > &""'"); 
   }
   arg2 = reinterpret_cast< std::vector< std::vector< double,std::allocator< double > > > * >(argp2);
   (arg1)->swap(*arg2);
@@ -10723,7 +10723,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_begin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_begin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -10736,7 +10736,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_begin(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_begin" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_begin" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = (arg1)->begin();
@@ -10748,7 +10748,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_end(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_end(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -10761,7 +10761,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_end(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_end" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_end" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = (arg1)->end();
@@ -10773,7 +10773,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_rbegin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_rbegin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -10786,7 +10786,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_rbegin(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_rbegin" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_rbegin" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = (arg1)->rbegin();
@@ -10798,7 +10798,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_rend(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_rend(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -10811,7 +10811,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_rend(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_rend" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_rend" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = (arg1)->rend();
@@ -10823,7 +10823,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_clear(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_clear(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -10835,7 +10835,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_clear(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_clear" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_clear" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   (arg1)->clear();
@@ -10846,7 +10846,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_get_allocator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_get_allocator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -10859,7 +10859,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_get_allocator(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_get_allocator" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_get_allocator" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = ((std::vector< std::vector< double > > const *)arg1)->get_allocator();
@@ -10870,7 +10870,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vdouble2d_t__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vdouble2d_T__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > >::size_type arg1 ;
   size_t val1 ;
@@ -10881,7 +10881,7 @@ SWIGINTERN PyObject *_wrap_new_vdouble2d_t__SWIG_2(PyObject *self, Py_ssize_t no
   if ((nobjs < 1) || (nobjs > 1)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vdouble2d_t" "', argument " "1"" of type '" "std::vector< std::vector< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vdouble2d_T" "', argument " "1"" of type '" "std::vector< std::vector< double > >::size_type""'");
   } 
   arg1 = static_cast< std::vector< std::vector< double > >::size_type >(val1);
   result = (std::vector< std::vector< double > > *)new std::vector< std::vector< double > >(arg1);
@@ -10892,7 +10892,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_pop_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_pop_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -10904,7 +10904,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_pop_back(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_pop_back" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_pop_back" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   (arg1)->pop_back();
@@ -10915,7 +10915,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::size_type arg2 ;
@@ -10928,12 +10928,12 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_resize__SWIG_0(PyObject *self, Py_ssize_t
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_resize" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_resize" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_t_resize" "', argument " "2"" of type '" "std::vector< std::vector< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_T_resize" "', argument " "2"" of type '" "std::vector< std::vector< double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< double > >::size_type >(val2);
   (arg1)->resize(arg2);
@@ -10944,7 +10944,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::iterator arg2 ;
@@ -10958,18 +10958,18 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_erase__SWIG_0(PyObject *self, Py_ssize_t
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_erase" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_erase" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t_erase" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T_erase" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t_erase" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T_erase" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
     }
   }
   result = std_vector_Sl_std_vector_Sl_double_Sg__Sg__erase__SWIG_0(arg1,SWIG_STD_MOVE(arg2));
@@ -10981,7 +10981,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::iterator arg2 ;
@@ -10998,29 +10998,29 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_erase__SWIG_1(PyObject *self, Py_ssize_t
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_erase" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_erase" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t_erase" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T_erase" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t_erase" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T_erase" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
     }
   }
   res3 = SWIG_ConvertPtr(swig_obj[2], SWIG_as_voidptrptr(&iter3), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res3) || !iter3) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t_erase" "', argument " "3"" of type '" "std::vector< std::vector< double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T_erase" "', argument " "3"" of type '" "std::vector< std::vector< double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *>(iter3);
     if (iter_t) {
       arg3 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t_erase" "', argument " "3"" of type '" "std::vector< std::vector< double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T_erase" "', argument " "3"" of type '" "std::vector< std::vector< double > >::iterator""'");
     }
   }
   result = std_vector_Sl_std_vector_Sl_double_Sg__Sg__erase__SWIG_1(arg1,SWIG_STD_MOVE(arg2),SWIG_STD_MOVE(arg3));
@@ -11032,13 +11032,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_erase(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_erase(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_t_erase", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_T_erase", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -11049,7 +11049,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_erase(PyObject *self, PyObject *args) {
       int res = SWIG_ConvertPtr(argv[1], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
       _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *>(iter) != 0));
       if (_v) {
-        return _wrap_vdouble2d_t_erase__SWIG_0(self, argc, argv);
+        return _wrap_vdouble2d_T_erase__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -11066,14 +11066,14 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_erase(PyObject *self, PyObject *args) {
         int res = SWIG_ConvertPtr(argv[2], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
         _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *>(iter) != 0));
         if (_v) {
-          return _wrap_vdouble2d_t_erase__SWIG_1(self, argc, argv);
+          return _wrap_vdouble2d_T_erase__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_t_erase'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_T_erase'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< double > >::erase(std::vector< std::vector< double > >::iterator)\n"
     "    std::vector< std::vector< double > >::erase(std::vector< std::vector< double > >::iterator,std::vector< std::vector< double > >::iterator)\n");
@@ -11081,7 +11081,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vdouble2d_t__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vdouble2d_T__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > >::size_type arg1 ;
   std::vector< std::vector< double > >::value_type *arg2 = 0 ;
@@ -11094,17 +11094,17 @@ SWIGINTERN PyObject *_wrap_new_vdouble2d_t__SWIG_3(PyObject *self, Py_ssize_t no
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vdouble2d_t" "', argument " "1"" of type '" "std::vector< std::vector< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vdouble2d_T" "', argument " "1"" of type '" "std::vector< std::vector< double > >::size_type""'");
   } 
   arg1 = static_cast< std::vector< std::vector< double > >::size_type >(val1);
   {
     std::vector< double,std::allocator< double > > *ptr = (std::vector< double,std::allocator< double > > *)0;
     res2 = swig::asptr(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "new_vdouble2d_t" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "new_vdouble2d_T" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vdouble2d_t" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vdouble2d_T" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -11118,16 +11118,16 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vdouble2d_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_new_vdouble2d_T(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vdouble2d_t", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vdouble2d_T", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 0) {
-    return _wrap_new_vdouble2d_t__SWIG_0(self, argc, argv);
+    return _wrap_new_vdouble2d_T__SWIG_0(self, argc, argv);
   }
   if (argc == 1) {
     int _v = 0;
@@ -11136,7 +11136,7 @@ SWIGINTERN PyObject *_wrap_new_vdouble2d_t(PyObject *self, PyObject *args) {
       _v = SWIG_CheckState(res);
     }
     if (_v) {
-      return _wrap_new_vdouble2d_t__SWIG_2(self, argc, argv);
+      return _wrap_new_vdouble2d_T__SWIG_2(self, argc, argv);
     }
   }
   if (argc == 1) {
@@ -11144,7 +11144,7 @@ SWIGINTERN PyObject *_wrap_new_vdouble2d_t(PyObject *self, PyObject *args) {
     int res = swig::asptr(argv[0], (std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > >**)(0));
     _v = SWIG_CheckState(res);
     if (_v) {
-      return _wrap_new_vdouble2d_t__SWIG_1(self, argc, argv);
+      return _wrap_new_vdouble2d_T__SWIG_1(self, argc, argv);
     }
   }
   if (argc == 2) {
@@ -11157,13 +11157,13 @@ SWIGINTERN PyObject *_wrap_new_vdouble2d_t(PyObject *self, PyObject *args) {
       int res = swig::asptr(argv[1], (std::vector< double,std::allocator< double > >**)(0));
       _v = SWIG_CheckState(res);
       if (_v) {
-        return _wrap_new_vdouble2d_t__SWIG_3(self, argc, argv);
+        return _wrap_new_vdouble2d_T__SWIG_3(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vdouble2d_t'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vdouble2d_T'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< double > >::vector()\n"
     "    std::vector< std::vector< double > >::vector(std::vector< std::vector< double,std::allocator< double > > > const &)\n"
@@ -11173,7 +11173,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_push_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_push_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::value_type *arg2 = 0 ;
@@ -11183,20 +11183,20 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_push_back(PyObject *self, PyObject *args)
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_t_push_back", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_T_push_back", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_push_back" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_push_back" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   {
     std::vector< double,std::allocator< double > > *ptr = (std::vector< double,std::allocator< double > > *)0;
     res2 = swig::asptr(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vdouble2d_t_push_back" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vdouble2d_T_push_back" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_t_push_back" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_T_push_back" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -11210,7 +11210,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_front(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_front(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -11223,7 +11223,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_front(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_front" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_front" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = (std::vector< std::vector< double > >::value_type *) &((std::vector< std::vector< double > > const *)arg1)->front();
@@ -11235,7 +11235,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -11248,7 +11248,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_back(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_back" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_back" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = (std::vector< std::vector< double > >::value_type *) &((std::vector< std::vector< double > > const *)arg1)->back();
@@ -11260,7 +11260,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_assign(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_assign(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::size_type arg2 ;
@@ -11273,25 +11273,25 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_assign(PyObject *self, PyObject *args) {
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_t_assign", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_T_assign", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_assign" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_assign" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_t_assign" "', argument " "2"" of type '" "std::vector< std::vector< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_T_assign" "', argument " "2"" of type '" "std::vector< std::vector< double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< double > >::size_type >(val2);
   {
     std::vector< double,std::allocator< double > > *ptr = (std::vector< double,std::allocator< double > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble2d_t_assign" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble2d_T_assign" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_t_assign" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_T_assign" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -11305,7 +11305,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::size_type arg2 ;
@@ -11320,22 +11320,22 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_resize__SWIG_1(PyObject *self, Py_ssize_t
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_resize" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_resize" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_t_resize" "', argument " "2"" of type '" "std::vector< std::vector< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_T_resize" "', argument " "2"" of type '" "std::vector< std::vector< double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< double > >::size_type >(val2);
   {
     std::vector< double,std::allocator< double > > *ptr = (std::vector< double,std::allocator< double > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble2d_t_resize" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble2d_T_resize" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_t_resize" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_T_resize" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -11349,13 +11349,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_resize(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_resize(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_t_resize", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_T_resize", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -11367,7 +11367,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_resize(PyObject *self, PyObject *args) {
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vdouble2d_t_resize__SWIG_0(self, argc, argv);
+        return _wrap_vdouble2d_T_resize__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -11384,14 +11384,14 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_resize(PyObject *self, PyObject *args) {
         int res = swig::asptr(argv[2], (std::vector< double,std::allocator< double > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vdouble2d_t_resize__SWIG_1(self, argc, argv);
+          return _wrap_vdouble2d_T_resize__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_t_resize'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_T_resize'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< double > >::resize(std::vector< std::vector< double > >::size_type)\n"
     "    std::vector< std::vector< double > >::resize(std::vector< std::vector< double > >::size_type,std::vector< std::vector< double > >::value_type const &)\n");
@@ -11399,7 +11399,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::iterator arg2 ;
@@ -11415,28 +11415,28 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_insert__SWIG_0(PyObject *self, Py_ssize_t
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_insert" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_insert" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t_insert" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T_insert" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t_insert" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T_insert" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
     }
   }
   {
     std::vector< double,std::allocator< double > > *ptr = (std::vector< double,std::allocator< double > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble2d_t_insert" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble2d_T_insert" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_t_insert" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_T_insert" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -11451,7 +11451,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::iterator arg2 ;
@@ -11469,33 +11469,33 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_insert__SWIG_1(PyObject *self, Py_ssize_t
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_insert" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_insert" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t_insert" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T_insert" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t_insert" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T_insert" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_size_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble2d_t_insert" "', argument " "3"" of type '" "std::vector< std::vector< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble2d_T_insert" "', argument " "3"" of type '" "std::vector< std::vector< double > >::size_type""'");
   } 
   arg3 = static_cast< std::vector< std::vector< double > >::size_type >(val3);
   {
     std::vector< double,std::allocator< double > > *ptr = (std::vector< double,std::allocator< double > > *)0;
     res4 = swig::asptr(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vdouble2d_t_insert" "', argument " "4"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vdouble2d_T_insert" "', argument " "4"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_t_insert" "', argument " "4"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_T_insert" "', argument " "4"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     arg4 = ptr;
   }
@@ -11509,13 +11509,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_insert(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_insert(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_t_insert", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_T_insert", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -11529,7 +11529,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_insert(PyObject *self, PyObject *args) {
         int res = swig::asptr(argv[2], (std::vector< double,std::allocator< double > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vdouble2d_t_insert__SWIG_0(self, argc, argv);
+          return _wrap_vdouble2d_T_insert__SWIG_0(self, argc, argv);
         }
       }
     }
@@ -11551,7 +11551,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_insert(PyObject *self, PyObject *args) {
           int res = swig::asptr(argv[3], (std::vector< double,std::allocator< double > >**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vdouble2d_t_insert__SWIG_1(self, argc, argv);
+            return _wrap_vdouble2d_T_insert__SWIG_1(self, argc, argv);
           }
         }
       }
@@ -11559,7 +11559,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_insert(PyObject *self, PyObject *args) {
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_t_insert'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_T_insert'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< double > >::insert(std::vector< std::vector< double > >::iterator,std::vector< std::vector< double > >::value_type const &)\n"
     "    std::vector< std::vector< double > >::insert(std::vector< std::vector< double > >::iterator,std::vector< std::vector< double > >::size_type,std::vector< std::vector< double > >::value_type const &)\n");
@@ -11567,7 +11567,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_reserve(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_reserve(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::size_type arg2 ;
@@ -11578,15 +11578,15 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_reserve(PyObject *self, PyObject *args) {
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_t_reserve", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_T_reserve", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_reserve" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_reserve" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_t_reserve" "', argument " "2"" of type '" "std::vector< std::vector< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_T_reserve" "', argument " "2"" of type '" "std::vector< std::vector< double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< double > >::size_type >(val2);
   (arg1)->reserve(arg2);
@@ -11597,7 +11597,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_capacity(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_capacity(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -11610,7 +11610,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_capacity(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_capacity" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_capacity" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = ((std::vector< std::vector< double > > const *)arg1)->capacity();
@@ -11621,7 +11621,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_delete_vdouble2d_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_delete_vdouble2d_T(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -11633,7 +11633,7 @@ SWIGINTERN PyObject *_wrap_delete_vdouble2d_t(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, SWIG_POINTER_DISOWN |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vdouble2d_t" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vdouble2d_T" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   {
@@ -11654,18 +11654,18 @@ fail:
 }
 
 
-SWIGINTERN PyObject *vdouble2d_t_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vdouble2d_T_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   PyObject *obj;
   if (!SWIG_Python_UnpackTuple(args, "swigregister", 1, 1, &obj)) return NULL;
   SWIG_TypeNewClientData(SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, SWIG_NewClientData(obj));
   return SWIG_Py_Void();
 }
 
-SWIGINTERN PyObject *vdouble2d_t_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vdouble2d_T_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   return SWIG_Python_InitShadowInstance(args);
 }
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_iterator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_iterator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   PyObject **arg2 = (PyObject **) 0 ;
@@ -11680,7 +11680,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_iterator(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_iterator" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_iterator" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = (swig::SwigPyIterator *)std_vector_Sl_int_Sg__iterator(arg1,arg2);
@@ -11691,7 +11691,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___nonzero__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___nonzero__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -11704,7 +11704,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___nonzero__(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___nonzero__" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___nonzero__" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = (bool)std_vector_Sl_int_Sg____nonzero__((std::vector< int > const *)arg1);
@@ -11715,7 +11715,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___bool__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___bool__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -11728,7 +11728,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___bool__(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___bool__" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___bool__" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = (bool)std_vector_Sl_int_Sg____bool__((std::vector< int > const *)arg1);
@@ -11739,7 +11739,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___len__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___len__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -11752,7 +11752,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___len__(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___len__" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___len__" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = std_vector_Sl_int_Sg____len__((std::vector< int > const *)arg1);
@@ -11763,7 +11763,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___getslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___getslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::difference_type arg2 ;
@@ -11778,20 +11778,20 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___getslice__(PyObject *self, PyObjec
   std::vector< int,std::allocator< int > > *result = 0 ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_integer_t___getslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_integer_T___getslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___getslice__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___getslice__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t___getslice__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T___getslice__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< int >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_t___getslice__" "', argument " "3"" of type '" "std::vector< int >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_T___getslice__" "', argument " "3"" of type '" "std::vector< int >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< int >::difference_type >(val3);
   try {
@@ -11808,7 +11808,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::difference_type arg2 ;
@@ -11824,17 +11824,17 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setslice____SWIG_0(PyObject *self,
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___setslice__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___setslice__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t___setslice__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T___setslice__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< int >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_t___setslice__" "', argument " "3"" of type '" "std::vector< int >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_T___setslice__" "', argument " "3"" of type '" "std::vector< int >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< int >::difference_type >(val3);
   try {
@@ -11851,7 +11851,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::difference_type arg2 ;
@@ -11869,27 +11869,27 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setslice____SWIG_1(PyObject *self,
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___setslice__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___setslice__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t___setslice__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T___setslice__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< int >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_t___setslice__" "', argument " "3"" of type '" "std::vector< int >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_T___setslice__" "', argument " "3"" of type '" "std::vector< int >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< int >::difference_type >(val3);
   {
     std::vector< int,std::allocator< int > > *ptr = (std::vector< int,std::allocator< int > > *)0;
     res4 = swig::asptr(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_integer_t___setslice__" "', argument " "4"" of type '" "std::vector< int,std::allocator< int > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_integer_T___setslice__" "', argument " "4"" of type '" "std::vector< int,std::allocator< int > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_integer_t___setslice__" "', argument " "4"" of type '" "std::vector< int,std::allocator< int > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_integer_T___setslice__" "', argument " "4"" of type '" "std::vector< int,std::allocator< int > > const &""'"); 
     }
     arg4 = ptr;
   }
@@ -11909,13 +11909,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___setslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___setslice__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_t___setslice__", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_T___setslice__", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -11932,7 +11932,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setslice__(PyObject *self, PyObjec
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_integer_t___setslice____SWIG_0(self, argc, argv);
+          return _wrap_vector_integer_T___setslice____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -11955,7 +11955,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setslice__(PyObject *self, PyObjec
           int res = swig::asptr(argv[3], (std::vector< int,std::allocator< int > >**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vector_integer_t___setslice____SWIG_1(self, argc, argv);
+            return _wrap_vector_integer_T___setslice____SWIG_1(self, argc, argv);
           }
         }
       }
@@ -11963,7 +11963,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setslice__(PyObject *self, PyObjec
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_t___setslice__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_T___setslice__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< int >::__setslice__(std::vector< int >::difference_type,std::vector< int >::difference_type)\n"
     "    std::vector< int >::__setslice__(std::vector< int >::difference_type,std::vector< int >::difference_type,std::vector< int,std::allocator< int > > const &)\n");
@@ -11971,7 +11971,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___delslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___delslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::difference_type arg2 ;
@@ -11985,20 +11985,20 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___delslice__(PyObject *self, PyObjec
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_integer_t___delslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_integer_T___delslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___delslice__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___delslice__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t___delslice__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T___delslice__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< int >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_t___delslice__" "', argument " "3"" of type '" "std::vector< int >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_T___delslice__" "', argument " "3"" of type '" "std::vector< int >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< int >::difference_type >(val3);
   try {
@@ -12015,7 +12015,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::difference_type arg2 ;
@@ -12028,12 +12028,12 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___delitem____SWIG_0(PyObject *self,
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___delitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___delitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t___delitem__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T___delitem__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< int >::difference_type >(val2);
   try {
@@ -12050,7 +12050,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -12062,12 +12062,12 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___getitem____SWIG_0(PyObject *self,
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___getitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___getitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -12085,7 +12085,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -12098,12 +12098,12 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setitem____SWIG_0(PyObject *self,
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___setitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___setitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -12111,10 +12111,10 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setitem____SWIG_0(PyObject *self,
     std::vector< int,std::allocator< int > > *ptr = (std::vector< int,std::allocator< int > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_integer_t___setitem__" "', argument " "3"" of type '" "std::vector< int,std::allocator< int > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_integer_T___setitem__" "', argument " "3"" of type '" "std::vector< int,std::allocator< int > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_integer_t___setitem__" "', argument " "3"" of type '" "std::vector< int,std::allocator< int > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_integer_T___setitem__" "', argument " "3"" of type '" "std::vector< int,std::allocator< int > > const &""'"); 
     }
     arg3 = ptr;
   }
@@ -12134,7 +12134,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -12145,12 +12145,12 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setitem____SWIG_1(PyObject *self,
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___setitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___setitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -12168,7 +12168,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -12179,12 +12179,12 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___delitem____SWIG_1(PyObject *self,
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___delitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___delitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -12202,13 +12202,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___delitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___delitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_t___delitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_T___delitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -12219,7 +12219,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___delitem__(PyObject *self, PyObject
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_integer_t___delitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_integer_T___delitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -12233,13 +12233,13 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___delitem__(PyObject *self, PyObject
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_integer_t___delitem____SWIG_0(self, argc, argv);
+        return _wrap_vector_integer_T___delitem____SWIG_0(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_t___delitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_T___delitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< int >::__delitem__(std::vector< int >::difference_type)\n"
     "    std::vector< int >::__delitem__(SWIGPY_SLICEOBJECT *)\n");
@@ -12247,7 +12247,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::difference_type arg2 ;
@@ -12261,12 +12261,12 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___getitem____SWIG_1(PyObject *self,
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___getitem__" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___getitem__" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t___getitem__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T___getitem__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< int >::difference_type >(val2);
   try {
@@ -12282,13 +12282,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___getitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___getitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_t___getitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_T___getitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -12299,7 +12299,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___getitem__(PyObject *self, PyObject
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_integer_t___getitem____SWIG_0(self, argc, argv);
+        return _wrap_vector_integer_T___getitem____SWIG_0(self, argc, argv);
       }
     }
   }
@@ -12313,13 +12313,13 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___getitem__(PyObject *self, PyObject
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_integer_t___getitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_integer_T___getitem____SWIG_1(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_t___getitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_T___getitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< int >::__getitem__(SWIGPY_SLICEOBJECT *)\n"
     "    std::vector< int >::__getitem__(std::vector< int >::difference_type) const\n");
@@ -12327,7 +12327,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::difference_type arg2 ;
@@ -12344,17 +12344,17 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setitem____SWIG_2(PyObject *self,
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___setitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___setitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t___setitem__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T___setitem__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< int >::difference_type >(val2);
   ecode3 = SWIG_AsVal_int(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_t___setitem__" "', argument " "3"" of type '" "std::vector< int >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_T___setitem__" "', argument " "3"" of type '" "std::vector< int >::value_type""'");
   } 
   temp3 = static_cast< std::vector< int >::value_type >(val3);
   arg3 = &temp3;
@@ -12370,13 +12370,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___setitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___setitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_t___setitem__", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_T___setitem__", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -12387,7 +12387,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setitem__(PyObject *self, PyObject
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_integer_t___setitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_integer_T___setitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -12403,7 +12403,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setitem__(PyObject *self, PyObject
         int res = swig::asptr(argv[2], (std::vector< int,std::allocator< int > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vector_integer_t___setitem____SWIG_0(self, argc, argv);
+          return _wrap_vector_integer_T___setitem____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -12423,14 +12423,14 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setitem__(PyObject *self, PyObject
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_integer_t___setitem____SWIG_2(self, argc, argv);
+          return _wrap_vector_integer_T___setitem____SWIG_2(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_t___setitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_T___setitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< int >::__setitem__(SWIGPY_SLICEOBJECT *,std::vector< int,std::allocator< int > > const &)\n"
     "    std::vector< int >::__setitem__(SWIGPY_SLICEOBJECT *)\n"
@@ -12439,7 +12439,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_pop(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_pop(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -12452,7 +12452,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_pop(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_pop" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_pop" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   try {
@@ -12467,7 +12467,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_append(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_append(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::value_type *arg2 = 0 ;
@@ -12479,15 +12479,15 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_append(PyObject *self, PyObject *arg
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_integer_t_append", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_integer_T_append", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_append" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_append" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_int(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t_append" "', argument " "2"" of type '" "std::vector< int >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T_append" "', argument " "2"" of type '" "std::vector< int >::value_type""'");
   } 
   temp2 = static_cast< std::vector< int >::value_type >(val2);
   arg2 = &temp2;
@@ -12499,7 +12499,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_integer_t__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
+SWIGINTERN PyObject *_wrap_new_vector_integer_T__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
   PyObject *resultobj = 0;
   std::vector< int > *result = 0 ;
   
@@ -12513,7 +12513,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_integer_t__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_integer_T__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = 0 ;
   int res1 = SWIG_OLDOBJ ;
@@ -12525,10 +12525,10 @@ SWIGINTERN PyObject *_wrap_new_vector_integer_t__SWIG_1(PyObject *self, Py_ssize
     std::vector< int,std::allocator< int > > *ptr = (std::vector< int,std::allocator< int > > *)0;
     res1 = swig::asptr(swig_obj[0], &ptr);
     if (!SWIG_IsOK(res1)) {
-      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vector_integer_t" "', argument " "1"" of type '" "std::vector< int > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vector_integer_T" "', argument " "1"" of type '" "std::vector< int > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_integer_t" "', argument " "1"" of type '" "std::vector< int > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_integer_T" "', argument " "1"" of type '" "std::vector< int > const &""'"); 
     }
     arg1 = ptr;
   }
@@ -12542,7 +12542,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_empty(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_empty(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -12555,7 +12555,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_empty(PyObject *self, PyObject *args
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_empty" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_empty" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = (bool)((std::vector< int > const *)arg1)->empty();
@@ -12566,7 +12566,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_size(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_size(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -12579,7 +12579,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_size(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_size" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_size" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = ((std::vector< int > const *)arg1)->size();
@@ -12590,7 +12590,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_swap(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_swap(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int > *arg2 = 0 ;
@@ -12601,18 +12601,18 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_swap(PyObject *self, PyObject *args)
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_integer_t_swap", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_integer_T_swap", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_swap" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_swap" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], &argp2, SWIGTYPE_p_std__vectorT_int_t,  0 );
   if (!SWIG_IsOK(res2)) {
-    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_integer_t_swap" "', argument " "2"" of type '" "std::vector< int > &""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_integer_T_swap" "', argument " "2"" of type '" "std::vector< int > &""'"); 
   }
   if (!argp2) {
-    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_integer_t_swap" "', argument " "2"" of type '" "std::vector< int > &""'"); 
+    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_integer_T_swap" "', argument " "2"" of type '" "std::vector< int > &""'"); 
   }
   arg2 = reinterpret_cast< std::vector< int > * >(argp2);
   (arg1)->swap(*arg2);
@@ -12623,7 +12623,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_begin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_begin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -12636,7 +12636,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_begin(PyObject *self, PyObject *args
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_begin" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_begin" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = (arg1)->begin();
@@ -12648,7 +12648,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_end(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_end(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -12661,7 +12661,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_end(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_end" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_end" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = (arg1)->end();
@@ -12673,7 +12673,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_rbegin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_rbegin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -12686,7 +12686,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_rbegin(PyObject *self, PyObject *arg
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_rbegin" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_rbegin" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = (arg1)->rbegin();
@@ -12698,7 +12698,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_rend(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_rend(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -12711,7 +12711,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_rend(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_rend" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_rend" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = (arg1)->rend();
@@ -12723,7 +12723,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_clear(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_clear(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -12735,7 +12735,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_clear(PyObject *self, PyObject *args
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_clear" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_clear" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   (arg1)->clear();
@@ -12746,7 +12746,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_get_allocator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_get_allocator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -12759,7 +12759,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_get_allocator(PyObject *self, PyObje
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_get_allocator" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_get_allocator" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = ((std::vector< int > const *)arg1)->get_allocator();
@@ -12770,7 +12770,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_integer_t__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_integer_T__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int >::size_type arg1 ;
   size_t val1 ;
@@ -12781,7 +12781,7 @@ SWIGINTERN PyObject *_wrap_new_vector_integer_t__SWIG_2(PyObject *self, Py_ssize
   if ((nobjs < 1) || (nobjs > 1)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_integer_t" "', argument " "1"" of type '" "std::vector< int >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_integer_T" "', argument " "1"" of type '" "std::vector< int >::size_type""'");
   } 
   arg1 = static_cast< std::vector< int >::size_type >(val1);
   result = (std::vector< int > *)new std::vector< int >(arg1);
@@ -12792,7 +12792,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_pop_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_pop_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -12804,7 +12804,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_pop_back(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_pop_back" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_pop_back" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   (arg1)->pop_back();
@@ -12815,7 +12815,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::size_type arg2 ;
@@ -12828,12 +12828,12 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_resize__SWIG_0(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_resize" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_resize" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t_resize" "', argument " "2"" of type '" "std::vector< int >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T_resize" "', argument " "2"" of type '" "std::vector< int >::size_type""'");
   } 
   arg2 = static_cast< std::vector< int >::size_type >(val2);
   (arg1)->resize(arg2);
@@ -12844,7 +12844,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::iterator arg2 ;
@@ -12858,18 +12858,18 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_erase__SWIG_0(PyObject *self, Py_ssi
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_erase" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_erase" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t_erase" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T_erase" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< int >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< int >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t_erase" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T_erase" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
     }
   }
   result = std_vector_Sl_int_Sg__erase__SWIG_0(arg1,SWIG_STD_MOVE(arg2));
@@ -12881,7 +12881,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::iterator arg2 ;
@@ -12898,29 +12898,29 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_erase__SWIG_1(PyObject *self, Py_ssi
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_erase" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_erase" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t_erase" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T_erase" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< int >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< int >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t_erase" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T_erase" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
     }
   }
   res3 = SWIG_ConvertPtr(swig_obj[2], SWIG_as_voidptrptr(&iter3), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res3) || !iter3) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t_erase" "', argument " "3"" of type '" "std::vector< int >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T_erase" "', argument " "3"" of type '" "std::vector< int >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< int >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< int >::iterator > *>(iter3);
     if (iter_t) {
       arg3 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t_erase" "', argument " "3"" of type '" "std::vector< int >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T_erase" "', argument " "3"" of type '" "std::vector< int >::iterator""'");
     }
   }
   result = std_vector_Sl_int_Sg__erase__SWIG_1(arg1,SWIG_STD_MOVE(arg2),SWIG_STD_MOVE(arg3));
@@ -12932,13 +12932,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_erase(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_erase(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_t_erase", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_T_erase", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -12949,7 +12949,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_erase(PyObject *self, PyObject *args
       int res = SWIG_ConvertPtr(argv[1], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
       _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< int >::iterator > *>(iter) != 0));
       if (_v) {
-        return _wrap_vector_integer_t_erase__SWIG_0(self, argc, argv);
+        return _wrap_vector_integer_T_erase__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -12966,14 +12966,14 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_erase(PyObject *self, PyObject *args
         int res = SWIG_ConvertPtr(argv[2], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
         _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< int >::iterator > *>(iter) != 0));
         if (_v) {
-          return _wrap_vector_integer_t_erase__SWIG_1(self, argc, argv);
+          return _wrap_vector_integer_T_erase__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_t_erase'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_T_erase'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< int >::erase(std::vector< int >::iterator)\n"
     "    std::vector< int >::erase(std::vector< int >::iterator,std::vector< int >::iterator)\n");
@@ -12981,7 +12981,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_integer_t__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_integer_T__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int >::size_type arg1 ;
   std::vector< int >::value_type *arg2 = 0 ;
@@ -12996,12 +12996,12 @@ SWIGINTERN PyObject *_wrap_new_vector_integer_t__SWIG_3(PyObject *self, Py_ssize
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_integer_t" "', argument " "1"" of type '" "std::vector< int >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_integer_T" "', argument " "1"" of type '" "std::vector< int >::size_type""'");
   } 
   arg1 = static_cast< std::vector< int >::size_type >(val1);
   ecode2 = SWIG_AsVal_int(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "new_vector_integer_t" "', argument " "2"" of type '" "std::vector< int >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "new_vector_integer_T" "', argument " "2"" of type '" "std::vector< int >::value_type""'");
   } 
   temp2 = static_cast< std::vector< int >::value_type >(val2);
   arg2 = &temp2;
@@ -13013,16 +13013,16 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_integer_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_new_vector_integer_T(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vector_integer_t", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vector_integer_T", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 0) {
-    return _wrap_new_vector_integer_t__SWIG_0(self, argc, argv);
+    return _wrap_new_vector_integer_T__SWIG_0(self, argc, argv);
   }
   if (argc == 1) {
     int _v = 0;
@@ -13031,7 +13031,7 @@ SWIGINTERN PyObject *_wrap_new_vector_integer_t(PyObject *self, PyObject *args)
       _v = SWIG_CheckState(res);
     }
     if (_v) {
-      return _wrap_new_vector_integer_t__SWIG_2(self, argc, argv);
+      return _wrap_new_vector_integer_T__SWIG_2(self, argc, argv);
     }
   }
   if (argc == 1) {
@@ -13039,7 +13039,7 @@ SWIGINTERN PyObject *_wrap_new_vector_integer_t(PyObject *self, PyObject *args)
     int res = swig::asptr(argv[0], (std::vector< int,std::allocator< int > >**)(0));
     _v = SWIG_CheckState(res);
     if (_v) {
-      return _wrap_new_vector_integer_t__SWIG_1(self, argc, argv);
+      return _wrap_new_vector_integer_T__SWIG_1(self, argc, argv);
     }
   }
   if (argc == 2) {
@@ -13054,13 +13054,13 @@ SWIGINTERN PyObject *_wrap_new_vector_integer_t(PyObject *self, PyObject *args)
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_new_vector_integer_t__SWIG_3(self, argc, argv);
+        return _wrap_new_vector_integer_T__SWIG_3(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vector_integer_t'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vector_integer_T'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< int >::vector()\n"
     "    std::vector< int >::vector(std::vector< int > const &)\n"
@@ -13070,7 +13070,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_push_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_push_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::value_type *arg2 = 0 ;
@@ -13082,15 +13082,15 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_push_back(PyObject *self, PyObject *
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_integer_t_push_back", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_integer_T_push_back", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_push_back" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_push_back" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_int(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t_push_back" "', argument " "2"" of type '" "std::vector< int >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T_push_back" "', argument " "2"" of type '" "std::vector< int >::value_type""'");
   } 
   temp2 = static_cast< std::vector< int >::value_type >(val2);
   arg2 = &temp2;
@@ -13102,7 +13102,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_front(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_front(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -13115,7 +13115,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_front(PyObject *self, PyObject *args
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_front" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_front" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = (std::vector< int >::value_type *) &((std::vector< int > const *)arg1)->front();
@@ -13127,7 +13127,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -13140,7 +13140,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_back(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_back" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_back" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = (std::vector< int >::value_type *) &((std::vector< int > const *)arg1)->back();
@@ -13152,7 +13152,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_assign(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_assign(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::size_type arg2 ;
@@ -13167,20 +13167,20 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_assign(PyObject *self, PyObject *arg
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_integer_t_assign", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_integer_T_assign", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_assign" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_assign" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t_assign" "', argument " "2"" of type '" "std::vector< int >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T_assign" "', argument " "2"" of type '" "std::vector< int >::size_type""'");
   } 
   arg2 = static_cast< std::vector< int >::size_type >(val2);
   ecode3 = SWIG_AsVal_int(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_t_assign" "', argument " "3"" of type '" "std::vector< int >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_T_assign" "', argument " "3"" of type '" "std::vector< int >::value_type""'");
   } 
   temp3 = static_cast< std::vector< int >::value_type >(val3);
   arg3 = &temp3;
@@ -13192,7 +13192,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::size_type arg2 ;
@@ -13209,17 +13209,17 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_resize__SWIG_1(PyObject *self, Py_ss
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_resize" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_resize" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t_resize" "', argument " "2"" of type '" "std::vector< int >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T_resize" "', argument " "2"" of type '" "std::vector< int >::size_type""'");
   } 
   arg2 = static_cast< std::vector< int >::size_type >(val2);
   ecode3 = SWIG_AsVal_int(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_t_resize" "', argument " "3"" of type '" "std::vector< int >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_T_resize" "', argument " "3"" of type '" "std::vector< int >::value_type""'");
   } 
   temp3 = static_cast< std::vector< int >::value_type >(val3);
   arg3 = &temp3;
@@ -13231,13 +13231,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_resize(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_resize(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_t_resize", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_T_resize", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -13249,7 +13249,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_resize(PyObject *self, PyObject *arg
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_integer_t_resize__SWIG_0(self, argc, argv);
+        return _wrap_vector_integer_T_resize__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -13268,14 +13268,14 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_resize(PyObject *self, PyObject *arg
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_integer_t_resize__SWIG_1(self, argc, argv);
+          return _wrap_vector_integer_T_resize__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_t_resize'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_T_resize'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< int >::resize(std::vector< int >::size_type)\n"
     "    std::vector< int >::resize(std::vector< int >::size_type,std::vector< int >::value_type const &)\n");
@@ -13283,7 +13283,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::iterator arg2 ;
@@ -13301,23 +13301,23 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_insert__SWIG_0(PyObject *self, Py_ss
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_insert" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_insert" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t_insert" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T_insert" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< int >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< int >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t_insert" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T_insert" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_int(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_t_insert" "', argument " "3"" of type '" "std::vector< int >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_T_insert" "', argument " "3"" of type '" "std::vector< int >::value_type""'");
   } 
   temp3 = static_cast< std::vector< int >::value_type >(val3);
   arg3 = &temp3;
@@ -13330,7 +13330,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::iterator arg2 ;
@@ -13350,28 +13350,28 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_insert__SWIG_1(PyObject *self, Py_ss
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_insert" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_insert" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t_insert" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T_insert" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< int >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< int >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t_insert" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T_insert" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_size_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_t_insert" "', argument " "3"" of type '" "std::vector< int >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_T_insert" "', argument " "3"" of type '" "std::vector< int >::size_type""'");
   } 
   arg3 = static_cast< std::vector< int >::size_type >(val3);
   ecode4 = SWIG_AsVal_int(swig_obj[3], &val4);
   if (!SWIG_IsOK(ecode4)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode4), "in method '" "vector_integer_t_insert" "', argument " "4"" of type '" "std::vector< int >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode4), "in method '" "vector_integer_T_insert" "', argument " "4"" of type '" "std::vector< int >::value_type""'");
   } 
   temp4 = static_cast< std::vector< int >::value_type >(val4);
   arg4 = &temp4;
@@ -13383,13 +13383,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_insert(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_insert(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_t_insert", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_T_insert", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -13405,7 +13405,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_insert(PyObject *self, PyObject *arg
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_integer_t_insert__SWIG_0(self, argc, argv);
+          return _wrap_vector_integer_T_insert__SWIG_0(self, argc, argv);
         }
       }
     }
@@ -13429,7 +13429,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_insert(PyObject *self, PyObject *arg
             _v = SWIG_CheckState(res);
           }
           if (_v) {
-            return _wrap_vector_integer_t_insert__SWIG_1(self, argc, argv);
+            return _wrap_vector_integer_T_insert__SWIG_1(self, argc, argv);
           }
         }
       }
@@ -13437,7 +13437,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_insert(PyObject *self, PyObject *arg
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_t_insert'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_T_insert'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< int >::insert(std::vector< int >::iterator,std::vector< int >::value_type const &)\n"
     "    std::vector< int >::insert(std::vector< int >::iterator,std::vector< int >::size_type,std::vector< int >::value_type const &)\n");
@@ -13445,7 +13445,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_reserve(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_reserve(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::size_type arg2 ;
@@ -13456,15 +13456,15 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_reserve(PyObject *self, PyObject *ar
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_integer_t_reserve", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_integer_T_reserve", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_reserve" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_reserve" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t_reserve" "', argument " "2"" of type '" "std::vector< int >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T_reserve" "', argument " "2"" of type '" "std::vector< int >::size_type""'");
   } 
   arg2 = static_cast< std::vector< int >::size_type >(val2);
   (arg1)->reserve(arg2);
@@ -13475,7 +13475,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_capacity(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_capacity(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -13488,7 +13488,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_capacity(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_capacity" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_capacity" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = ((std::vector< int > const *)arg1)->capacity();
@@ -13499,7 +13499,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_delete_vector_integer_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_delete_vector_integer_T(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -13511,7 +13511,7 @@ SWIGINTERN PyObject *_wrap_delete_vector_integer_t(PyObject *self, PyObject *arg
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, SWIG_POINTER_DISOWN |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vector_integer_t" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vector_integer_T" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   {
@@ -13532,18 +13532,18 @@ fail:
 }
 
 
-SWIGINTERN PyObject *vector_integer_t_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vector_integer_T_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   PyObject *obj;
   if (!SWIG_Python_UnpackTuple(args, "swigregister", 1, 1, &obj)) return NULL;
   SWIG_TypeNewClientData(SWIGTYPE_p_std__vectorT_int_t, SWIG_NewClientData(obj));
   return SWIG_Py_Void();
 }
 
-SWIGINTERN PyObject *vector_integer_t_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vector_integer_T_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   return SWIG_Python_InitShadowInstance(args);
 }
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_iterator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_iterator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   PyObject **arg2 = (PyObject **) 0 ;
@@ -13558,7 +13558,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_iterator(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_iterator" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_iterator" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = (swig::SwigPyIterator *)std_vector_Sl_std_vector_Sl_int_Sg__Sg__iterator(arg1,arg2);
@@ -13569,7 +13569,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___nonzero__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___nonzero__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -13582,7 +13582,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___nonzero__(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___nonzero__" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___nonzero__" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = (bool)std_vector_Sl_std_vector_Sl_int_Sg__Sg____nonzero__((std::vector< std::vector< int > > const *)arg1);
@@ -13593,7 +13593,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___bool__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___bool__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -13606,7 +13606,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___bool__(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___bool__" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___bool__" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = (bool)std_vector_Sl_std_vector_Sl_int_Sg__Sg____bool__((std::vector< std::vector< int > > const *)arg1);
@@ -13617,7 +13617,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___len__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___len__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -13630,7 +13630,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___len__(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___len__" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___len__" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = std_vector_Sl_std_vector_Sl_int_Sg__Sg____len__((std::vector< std::vector< int > > const *)arg1);
@@ -13641,7 +13641,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___getslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___getslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::difference_type arg2 ;
@@ -13656,20 +13656,20 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___getslice__(PyObject *self, PyObject *a
   std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > *result = 0 ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_t___getslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_T___getslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___getslice__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___getslice__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_t___getslice__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_T___getslice__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< int > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vinteger2d_t___getslice__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vinteger2d_T___getslice__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::vector< int > >::difference_type >(val3);
   try {
@@ -13686,7 +13686,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::difference_type arg2 ;
@@ -13702,17 +13702,17 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setslice____SWIG_0(PyObject *self, Py_
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___setslice__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___setslice__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_t___setslice__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_T___setslice__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< int > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vinteger2d_t___setslice__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vinteger2d_T___setslice__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::vector< int > >::difference_type >(val3);
   try {
@@ -13729,7 +13729,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::difference_type arg2 ;
@@ -13747,27 +13747,27 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setslice____SWIG_1(PyObject *self, Py_
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___setslice__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___setslice__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_t___setslice__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_T___setslice__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< int > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vinteger2d_t___setslice__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vinteger2d_T___setslice__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::vector< int > >::difference_type >(val3);
   {
     std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > *ptr = (std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > *)0;
     res4 = swig::asptr(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vinteger2d_t___setslice__" "', argument " "4"" of type '" "std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vinteger2d_T___setslice__" "', argument " "4"" of type '" "std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_t___setslice__" "', argument " "4"" of type '" "std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_T___setslice__" "', argument " "4"" of type '" "std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > const &""'"); 
     }
     arg4 = ptr;
   }
@@ -13787,13 +13787,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___setslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___setslice__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_t___setslice__", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_T___setslice__", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -13810,7 +13810,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setslice__(PyObject *self, PyObject *a
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vinteger2d_t___setslice____SWIG_0(self, argc, argv);
+          return _wrap_vinteger2d_T___setslice____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -13833,7 +13833,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setslice__(PyObject *self, PyObject *a
           int res = swig::asptr(argv[3], (std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > >**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vinteger2d_t___setslice____SWIG_1(self, argc, argv);
+            return _wrap_vinteger2d_T___setslice____SWIG_1(self, argc, argv);
           }
         }
       }
@@ -13841,7 +13841,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setslice__(PyObject *self, PyObject *a
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_t___setslice__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_T___setslice__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< int > >::__setslice__(std::vector< std::vector< int > >::difference_type,std::vector< std::vector< int > >::difference_type)\n"
     "    std::vector< std::vector< int > >::__setslice__(std::vector< std::vector< int > >::difference_type,std::vector< std::vector< int > >::difference_type,std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > const &)\n");
@@ -13849,7 +13849,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___delslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___delslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::difference_type arg2 ;
@@ -13863,20 +13863,20 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___delslice__(PyObject *self, PyObject *a
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_t___delslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_T___delslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___delslice__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___delslice__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_t___delslice__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_T___delslice__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< int > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vinteger2d_t___delslice__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vinteger2d_T___delslice__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::vector< int > >::difference_type >(val3);
   try {
@@ -13893,7 +13893,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::difference_type arg2 ;
@@ -13906,12 +13906,12 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___delitem____SWIG_0(PyObject *self, Py_s
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___delitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___delitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_t___delitem__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_T___delitem__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< int > >::difference_type >(val2);
   try {
@@ -13928,7 +13928,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -13940,12 +13940,12 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___getitem____SWIG_0(PyObject *self, Py_s
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___getitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___getitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -13963,7 +13963,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -13976,12 +13976,12 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setitem____SWIG_0(PyObject *self, Py_s
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -13989,10 +13989,10 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setitem____SWIG_0(PyObject *self, Py_s
     std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > *ptr = (std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vinteger2d_t___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vinteger2d_T___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_t___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_T___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > const &""'"); 
     }
     arg3 = ptr;
   }
@@ -14012,7 +14012,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -14023,12 +14023,12 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setitem____SWIG_1(PyObject *self, Py_s
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -14046,7 +14046,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -14057,12 +14057,12 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___delitem____SWIG_1(PyObject *self, Py_s
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___delitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___delitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -14080,13 +14080,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___delitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___delitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_t___delitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_T___delitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -14097,7 +14097,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___delitem__(PyObject *self, PyObject *ar
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vinteger2d_t___delitem____SWIG_1(self, argc, argv);
+        return _wrap_vinteger2d_T___delitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -14111,13 +14111,13 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___delitem__(PyObject *self, PyObject *ar
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vinteger2d_t___delitem____SWIG_0(self, argc, argv);
+        return _wrap_vinteger2d_T___delitem____SWIG_0(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_t___delitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_T___delitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< int > >::__delitem__(std::vector< std::vector< int > >::difference_type)\n"
     "    std::vector< std::vector< int > >::__delitem__(SWIGPY_SLICEOBJECT *)\n");
@@ -14125,7 +14125,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::difference_type arg2 ;
@@ -14139,12 +14139,12 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___getitem____SWIG_1(PyObject *self, Py_s
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___getitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___getitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_t___getitem__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_T___getitem__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< int > >::difference_type >(val2);
   try {
@@ -14160,13 +14160,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___getitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___getitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_t___getitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_T___getitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -14177,7 +14177,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___getitem__(PyObject *self, PyObject *ar
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vinteger2d_t___getitem____SWIG_0(self, argc, argv);
+        return _wrap_vinteger2d_T___getitem____SWIG_0(self, argc, argv);
       }
     }
   }
@@ -14191,13 +14191,13 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___getitem__(PyObject *self, PyObject *ar
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vinteger2d_t___getitem____SWIG_1(self, argc, argv);
+        return _wrap_vinteger2d_T___getitem____SWIG_1(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_t___getitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_T___getitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< int > >::__getitem__(SWIGPY_SLICEOBJECT *)\n"
     "    std::vector< std::vector< int > >::__getitem__(std::vector< std::vector< int > >::difference_type) const\n");
@@ -14205,7 +14205,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::difference_type arg2 ;
@@ -14220,22 +14220,22 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setitem____SWIG_2(PyObject *self, Py_s
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_t___setitem__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_T___setitem__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< int > >::difference_type >(val2);
   {
     std::vector< int,std::allocator< int > > *ptr = (std::vector< int,std::allocator< int > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vinteger2d_t___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vinteger2d_T___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_t___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_T___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -14253,13 +14253,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___setitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___setitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_t___setitem__", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_T___setitem__", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -14270,7 +14270,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setitem__(PyObject *self, PyObject *ar
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vinteger2d_t___setitem____SWIG_1(self, argc, argv);
+        return _wrap_vinteger2d_T___setitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -14286,7 +14286,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setitem__(PyObject *self, PyObject *ar
         int res = swig::asptr(argv[2], (std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vinteger2d_t___setitem____SWIG_0(self, argc, argv);
+          return _wrap_vinteger2d_T___setitem____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -14304,14 +14304,14 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setitem__(PyObject *self, PyObject *ar
         int res = swig::asptr(argv[2], (std::vector< int,std::allocator< int > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vinteger2d_t___setitem____SWIG_2(self, argc, argv);
+          return _wrap_vinteger2d_T___setitem____SWIG_2(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_t___setitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_T___setitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< int > >::__setitem__(SWIGPY_SLICEOBJECT *,std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > const &)\n"
     "    std::vector< std::vector< int > >::__setitem__(SWIGPY_SLICEOBJECT *)\n"
@@ -14320,7 +14320,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_pop(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_pop(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -14333,7 +14333,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_pop(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_pop" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_pop" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   try {
@@ -14348,7 +14348,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_append(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_append(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::value_type *arg2 = 0 ;
@@ -14358,20 +14358,20 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_append(PyObject *self, PyObject *args) {
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_t_append", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_T_append", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_append" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_append" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   {
     std::vector< int,std::allocator< int > > *ptr = (std::vector< int,std::allocator< int > > *)0;
     res2 = swig::asptr(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vinteger2d_t_append" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vinteger2d_T_append" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_t_append" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_T_append" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -14385,7 +14385,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vinteger2d_t__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
+SWIGINTERN PyObject *_wrap_new_vinteger2d_T__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *result = 0 ;
   
@@ -14399,7 +14399,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vinteger2d_t__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vinteger2d_T__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int,std::allocator< int > > > *arg1 = 0 ;
   int res1 = SWIG_OLDOBJ ;
@@ -14411,10 +14411,10 @@ SWIGINTERN PyObject *_wrap_new_vinteger2d_t__SWIG_1(PyObject *self, Py_ssize_t n
     std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > *ptr = (std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > *)0;
     res1 = swig::asptr(swig_obj[0], &ptr);
     if (!SWIG_IsOK(res1)) {
-      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vinteger2d_t" "', argument " "1"" of type '" "std::vector< std::vector< int,std::allocator< int > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vinteger2d_T" "', argument " "1"" of type '" "std::vector< std::vector< int,std::allocator< int > > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vinteger2d_t" "', argument " "1"" of type '" "std::vector< std::vector< int,std::allocator< int > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vinteger2d_T" "', argument " "1"" of type '" "std::vector< std::vector< int,std::allocator< int > > > const &""'"); 
     }
     arg1 = ptr;
   }
@@ -14428,7 +14428,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_empty(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_empty(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -14441,7 +14441,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_empty(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_empty" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_empty" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = (bool)((std::vector< std::vector< int > > const *)arg1)->empty();
@@ -14452,7 +14452,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_size(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_size(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -14465,7 +14465,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_size(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_size" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_size" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = ((std::vector< std::vector< int > > const *)arg1)->size();
@@ -14476,7 +14476,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_swap(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_swap(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int,std::allocator< int > > > *arg2 = 0 ;
@@ -14487,18 +14487,18 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_swap(PyObject *self, PyObject *args) {
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_t_swap", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_T_swap", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_swap" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_swap" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], &argp2, SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t,  0 );
   if (!SWIG_IsOK(res2)) {
-    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vinteger2d_t_swap" "', argument " "2"" of type '" "std::vector< std::vector< int,std::allocator< int > > > &""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vinteger2d_T_swap" "', argument " "2"" of type '" "std::vector< std::vector< int,std::allocator< int > > > &""'"); 
   }
   if (!argp2) {
-    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_t_swap" "', argument " "2"" of type '" "std::vector< std::vector< int,std::allocator< int > > > &""'"); 
+    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_T_swap" "', argument " "2"" of type '" "std::vector< std::vector< int,std::allocator< int > > > &""'"); 
   }
   arg2 = reinterpret_cast< std::vector< std::vector< int,std::allocator< int > > > * >(argp2);
   (arg1)->swap(*arg2);
@@ -14509,7 +14509,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_begin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_begin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -14522,7 +14522,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_begin(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_begin" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_begin" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = (arg1)->begin();
@@ -14534,7 +14534,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_end(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_end(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -14547,7 +14547,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_end(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_end" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_end" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = (arg1)->end();
@@ -14559,7 +14559,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_rbegin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_rbegin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -14572,7 +14572,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_rbegin(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_rbegin" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_rbegin" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = (arg1)->rbegin();
@@ -14584,7 +14584,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_rend(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_rend(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -14597,7 +14597,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_rend(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_rend" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_rend" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = (arg1)->rend();
@@ -14609,7 +14609,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_clear(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_clear(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -14621,7 +14621,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_clear(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_clear" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_clear" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   (arg1)->clear();
@@ -14632,7 +14632,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_get_allocator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_get_allocator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -14645,7 +14645,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_get_allocator(PyObject *self, PyObject *
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_get_allocator" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_get_allocator" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = ((std::vector< std::vector< int > > const *)arg1)->get_allocator();
@@ -14656,7 +14656,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vinteger2d_t__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vinteger2d_T__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > >::size_type arg1 ;
   size_t val1 ;
@@ -14667,7 +14667,7 @@ SWIGINTERN PyObject *_wrap_new_vinteger2d_t__SWIG_2(PyObject *self, Py_ssize_t n
   if ((nobjs < 1) || (nobjs > 1)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vinteger2d_t" "', argument " "1"" of type '" "std::vector< std::vector< int > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vinteger2d_T" "', argument " "1"" of type '" "std::vector< std::vector< int > >::size_type""'");
   } 
   arg1 = static_cast< std::vector< std::vector< int > >::size_type >(val1);
   result = (std::vector< std::vector< int > > *)new std::vector< std::vector< int > >(arg1);
@@ -14678,7 +14678,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_pop_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_pop_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -14690,7 +14690,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_pop_back(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_pop_back" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_pop_back" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   (arg1)->pop_back();
@@ -14701,7 +14701,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::size_type arg2 ;
@@ -14714,12 +14714,12 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_resize__SWIG_0(PyObject *self, Py_ssize_
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_resize" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_resize" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_t_resize" "', argument " "2"" of type '" "std::vector< std::vector< int > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_T_resize" "', argument " "2"" of type '" "std::vector< std::vector< int > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< int > >::size_type >(val2);
   (arg1)->resize(arg2);
@@ -14730,7 +14730,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::iterator arg2 ;
@@ -14744,18 +14744,18 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_erase__SWIG_0(PyObject *self, Py_ssize_t
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_erase" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_erase" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t_erase" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T_erase" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t_erase" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T_erase" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
     }
   }
   result = std_vector_Sl_std_vector_Sl_int_Sg__Sg__erase__SWIG_0(arg1,SWIG_STD_MOVE(arg2));
@@ -14767,7 +14767,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::iterator arg2 ;
@@ -14784,29 +14784,29 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_erase__SWIG_1(PyObject *self, Py_ssize_t
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_erase" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_erase" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t_erase" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T_erase" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t_erase" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T_erase" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
     }
   }
   res3 = SWIG_ConvertPtr(swig_obj[2], SWIG_as_voidptrptr(&iter3), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res3) || !iter3) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t_erase" "', argument " "3"" of type '" "std::vector< std::vector< int > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T_erase" "', argument " "3"" of type '" "std::vector< std::vector< int > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *>(iter3);
     if (iter_t) {
       arg3 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t_erase" "', argument " "3"" of type '" "std::vector< std::vector< int > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T_erase" "', argument " "3"" of type '" "std::vector< std::vector< int > >::iterator""'");
     }
   }
   result = std_vector_Sl_std_vector_Sl_int_Sg__Sg__erase__SWIG_1(arg1,SWIG_STD_MOVE(arg2),SWIG_STD_MOVE(arg3));
@@ -14818,13 +14818,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_erase(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_erase(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_t_erase", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_T_erase", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -14835,7 +14835,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_erase(PyObject *self, PyObject *args) {
       int res = SWIG_ConvertPtr(argv[1], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
       _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *>(iter) != 0));
       if (_v) {
-        return _wrap_vinteger2d_t_erase__SWIG_0(self, argc, argv);
+        return _wrap_vinteger2d_T_erase__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -14852,14 +14852,14 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_erase(PyObject *self, PyObject *args) {
         int res = SWIG_ConvertPtr(argv[2], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
         _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *>(iter) != 0));
         if (_v) {
-          return _wrap_vinteger2d_t_erase__SWIG_1(self, argc, argv);
+          return _wrap_vinteger2d_T_erase__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_t_erase'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_T_erase'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< int > >::erase(std::vector< std::vector< int > >::iterator)\n"
     "    std::vector< std::vector< int > >::erase(std::vector< std::vector< int > >::iterator,std::vector< std::vector< int > >::iterator)\n");
@@ -14867,7 +14867,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vinteger2d_t__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vinteger2d_T__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > >::size_type arg1 ;
   std::vector< std::vector< int > >::value_type *arg2 = 0 ;
@@ -14880,17 +14880,17 @@ SWIGINTERN PyObject *_wrap_new_vinteger2d_t__SWIG_3(PyObject *self, Py_ssize_t n
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vinteger2d_t" "', argument " "1"" of type '" "std::vector< std::vector< int > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vinteger2d_T" "', argument " "1"" of type '" "std::vector< std::vector< int > >::size_type""'");
   } 
   arg1 = static_cast< std::vector< std::vector< int > >::size_type >(val1);
   {
     std::vector< int,std::allocator< int > > *ptr = (std::vector< int,std::allocator< int > > *)0;
     res2 = swig::asptr(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "new_vinteger2d_t" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "new_vinteger2d_T" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vinteger2d_t" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vinteger2d_T" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -14904,16 +14904,16 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vinteger2d_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_new_vinteger2d_T(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vinteger2d_t", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vinteger2d_T", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 0) {
-    return _wrap_new_vinteger2d_t__SWIG_0(self, argc, argv);
+    return _wrap_new_vinteger2d_T__SWIG_0(self, argc, argv);
   }
   if (argc == 1) {
     int _v = 0;
@@ -14922,7 +14922,7 @@ SWIGINTERN PyObject *_wrap_new_vinteger2d_t(PyObject *self, PyObject *args) {
       _v = SWIG_CheckState(res);
     }
     if (_v) {
-      return _wrap_new_vinteger2d_t__SWIG_2(self, argc, argv);
+      return _wrap_new_vinteger2d_T__SWIG_2(self, argc, argv);
     }
   }
   if (argc == 1) {
@@ -14930,7 +14930,7 @@ SWIGINTERN PyObject *_wrap_new_vinteger2d_t(PyObject *self, PyObject *args) {
     int res = swig::asptr(argv[0], (std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > >**)(0));
     _v = SWIG_CheckState(res);
     if (_v) {
-      return _wrap_new_vinteger2d_t__SWIG_1(self, argc, argv);
+      return _wrap_new_vinteger2d_T__SWIG_1(self, argc, argv);
     }
   }
   if (argc == 2) {
@@ -14943,13 +14943,13 @@ SWIGINTERN PyObject *_wrap_new_vinteger2d_t(PyObject *self, PyObject *args) {
       int res = swig::asptr(argv[1], (std::vector< int,std::allocator< int > >**)(0));
       _v = SWIG_CheckState(res);
       if (_v) {
-        return _wrap_new_vinteger2d_t__SWIG_3(self, argc, argv);
+        return _wrap_new_vinteger2d_T__SWIG_3(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vinteger2d_t'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vinteger2d_T'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< int > >::vector()\n"
     "    std::vector< std::vector< int > >::vector(std::vector< std::vector< int,std::allocator< int > > > const &)\n"
@@ -14959,7 +14959,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_push_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_push_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::value_type *arg2 = 0 ;
@@ -14969,20 +14969,20 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_push_back(PyObject *self, PyObject *args
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_t_push_back", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_T_push_back", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_push_back" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_push_back" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   {
     std::vector< int,std::allocator< int > > *ptr = (std::vector< int,std::allocator< int > > *)0;
     res2 = swig::asptr(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vinteger2d_t_push_back" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vinteger2d_T_push_back" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_t_push_back" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_T_push_back" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -14996,7 +14996,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_front(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_front(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -15009,7 +15009,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_front(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_front" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_front" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = (std::vector< std::vector< int > >::value_type *) &((std::vector< std::vector< int > > const *)arg1)->front();
@@ -15021,7 +15021,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -15034,7 +15034,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_back(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_back" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_back" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = (std::vector< std::vector< int > >::value_type *) &((std::vector< std::vector< int > > const *)arg1)->back();
@@ -15046,7 +15046,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_assign(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_assign(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::size_type arg2 ;
@@ -15059,25 +15059,25 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_assign(PyObject *self, PyObject *args) {
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_t_assign", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_T_assign", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_assign" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_assign" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_t_assign" "', argument " "2"" of type '" "std::vector< std::vector< int > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_T_assign" "', argument " "2"" of type '" "std::vector< std::vector< int > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< int > >::size_type >(val2);
   {
     std::vector< int,std::allocator< int > > *ptr = (std::vector< int,std::allocator< int > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vinteger2d_t_assign" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vinteger2d_T_assign" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_t_assign" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_T_assign" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -15091,7 +15091,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::size_type arg2 ;
@@ -15106,22 +15106,22 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_resize__SWIG_1(PyObject *self, Py_ssize_
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_resize" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_resize" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_t_resize" "', argument " "2"" of type '" "std::vector< std::vector< int > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_T_resize" "', argument " "2"" of type '" "std::vector< std::vector< int > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< int > >::size_type >(val2);
   {
     std::vector< int,std::allocator< int > > *ptr = (std::vector< int,std::allocator< int > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vinteger2d_t_resize" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vinteger2d_T_resize" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_t_resize" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_T_resize" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -15135,13 +15135,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_resize(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_resize(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_t_resize", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_T_resize", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -15153,7 +15153,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_resize(PyObject *self, PyObject *args) {
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vinteger2d_t_resize__SWIG_0(self, argc, argv);
+        return _wrap_vinteger2d_T_resize__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -15170,14 +15170,14 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_resize(PyObject *self, PyObject *args) {
         int res = swig::asptr(argv[2], (std::vector< int,std::allocator< int > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vinteger2d_t_resize__SWIG_1(self, argc, argv);
+          return _wrap_vinteger2d_T_resize__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_t_resize'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_T_resize'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< int > >::resize(std::vector< std::vector< int > >::size_type)\n"
     "    std::vector< std::vector< int > >::resize(std::vector< std::vector< int > >::size_type,std::vector< std::vector< int > >::value_type const &)\n");
@@ -15185,7 +15185,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::iterator arg2 ;
@@ -15201,28 +15201,28 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_insert__SWIG_0(PyObject *self, Py_ssize_
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_insert" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_insert" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t_insert" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T_insert" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t_insert" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T_insert" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
     }
   }
   {
     std::vector< int,std::allocator< int > > *ptr = (std::vector< int,std::allocator< int > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vinteger2d_t_insert" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vinteger2d_T_insert" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_t_insert" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_T_insert" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -15237,7 +15237,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::iterator arg2 ;
@@ -15255,33 +15255,33 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_insert__SWIG_1(PyObject *self, Py_ssize_
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_insert" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_insert" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t_insert" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T_insert" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t_insert" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T_insert" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_size_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vinteger2d_t_insert" "', argument " "3"" of type '" "std::vector< std::vector< int > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vinteger2d_T_insert" "', argument " "3"" of type '" "std::vector< std::vector< int > >::size_type""'");
   } 
   arg3 = static_cast< std::vector< std::vector< int > >::size_type >(val3);
   {
     std::vector< int,std::allocator< int > > *ptr = (std::vector< int,std::allocator< int > > *)0;
     res4 = swig::asptr(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vinteger2d_t_insert" "', argument " "4"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vinteger2d_T_insert" "', argument " "4"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_t_insert" "', argument " "4"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_T_insert" "', argument " "4"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     arg4 = ptr;
   }
@@ -15295,13 +15295,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_insert(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_insert(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_t_insert", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_T_insert", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -15315,7 +15315,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_insert(PyObject *self, PyObject *args) {
         int res = swig::asptr(argv[2], (std::vector< int,std::allocator< int > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vinteger2d_t_insert__SWIG_0(self, argc, argv);
+          return _wrap_vinteger2d_T_insert__SWIG_0(self, argc, argv);
         }
       }
     }
@@ -15337,7 +15337,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_insert(PyObject *self, PyObject *args) {
           int res = swig::asptr(argv[3], (std::vector< int,std::allocator< int > >**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vinteger2d_t_insert__SWIG_1(self, argc, argv);
+            return _wrap_vinteger2d_T_insert__SWIG_1(self, argc, argv);
           }
         }
       }
@@ -15345,7 +15345,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_insert(PyObject *self, PyObject *args) {
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_t_insert'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_T_insert'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< int > >::insert(std::vector< std::vector< int > >::iterator,std::vector< std::vector< int > >::value_type const &)\n"
     "    std::vector< std::vector< int > >::insert(std::vector< std::vector< int > >::iterator,std::vector< std::vector< int > >::size_type,std::vector< std::vector< int > >::value_type const &)\n");
@@ -15353,7 +15353,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_reserve(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_reserve(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::size_type arg2 ;
@@ -15364,15 +15364,15 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_reserve(PyObject *self, PyObject *args)
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_t_reserve", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_T_reserve", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_reserve" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_reserve" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_t_reserve" "', argument " "2"" of type '" "std::vector< std::vector< int > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_T_reserve" "', argument " "2"" of type '" "std::vector< std::vector< int > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< int > >::size_type >(val2);
   (arg1)->reserve(arg2);
@@ -15383,7 +15383,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_capacity(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_capacity(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -15396,7 +15396,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_capacity(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_capacity" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_capacity" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = ((std::vector< std::vector< int > > const *)arg1)->capacity();
@@ -15407,7 +15407,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_delete_vinteger2d_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_delete_vinteger2d_T(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -15419,7 +15419,7 @@ SWIGINTERN PyObject *_wrap_delete_vinteger2d_t(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, SWIG_POINTER_DISOWN |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vinteger2d_t" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vinteger2d_T" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   {
@@ -15440,18 +15440,18 @@ fail:
 }
 
 
-SWIGINTERN PyObject *vinteger2d_t_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vinteger2d_T_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   PyObject *obj;
   if (!SWIG_Python_UnpackTuple(args, "swigregister", 1, 1, &obj)) return NULL;
   SWIG_TypeNewClientData(SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, SWIG_NewClientData(obj));
   return SWIG_Py_Void();
 }
 
-SWIGINTERN PyObject *vinteger2d_t_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vinteger2d_T_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   return SWIG_Python_InitShadowInstance(args);
 }
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_iterator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_iterator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   PyObject **arg2 = (PyObject **) 0 ;
@@ -15466,7 +15466,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_iterator(PyObject *self, PyObjec
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_iterator" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_iterator" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = (swig::SwigPyIterator *)std_vector_Sl_unsigned_SS_long_Sg__iterator(arg1,arg2);
@@ -15477,7 +15477,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___nonzero__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___nonzero__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -15490,7 +15490,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___nonzero__(PyObject *self, PyOb
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___nonzero__" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___nonzero__" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = (bool)std_vector_Sl_unsigned_SS_long_Sg____nonzero__((std::vector< unsigned long > const *)arg1);
@@ -15501,7 +15501,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___bool__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___bool__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -15514,7 +15514,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___bool__(PyObject *self, PyObjec
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___bool__" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___bool__" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = (bool)std_vector_Sl_unsigned_SS_long_Sg____bool__((std::vector< unsigned long > const *)arg1);
@@ -15525,7 +15525,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___len__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___len__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -15538,7 +15538,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___len__(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___len__" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___len__" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = std_vector_Sl_unsigned_SS_long_Sg____len__((std::vector< unsigned long > const *)arg1);
@@ -15549,7 +15549,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___getslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___getslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::difference_type arg2 ;
@@ -15564,20 +15564,20 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___getslice__(PyObject *self, PyO
   std::vector< unsigned long,std::allocator< unsigned long > > *result = 0 ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_t___getslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_T___getslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___getslice__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___getslice__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t___getslice__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T___getslice__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< unsigned long >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_t___getslice__" "', argument " "3"" of type '" "std::vector< unsigned long >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_T___getslice__" "', argument " "3"" of type '" "std::vector< unsigned long >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< unsigned long >::difference_type >(val3);
   try {
@@ -15594,7 +15594,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::difference_type arg2 ;
@@ -15610,17 +15610,17 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setslice____SWIG_0(PyObject *s
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___setslice__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___setslice__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t___setslice__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T___setslice__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< unsigned long >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_t___setslice__" "', argument " "3"" of type '" "std::vector< unsigned long >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_T___setslice__" "', argument " "3"" of type '" "std::vector< unsigned long >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< unsigned long >::difference_type >(val3);
   try {
@@ -15637,7 +15637,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::difference_type arg2 ;
@@ -15655,27 +15655,27 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setslice____SWIG_1(PyObject *s
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___setslice__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___setslice__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t___setslice__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T___setslice__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< unsigned long >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_t___setslice__" "', argument " "3"" of type '" "std::vector< unsigned long >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_T___setslice__" "', argument " "3"" of type '" "std::vector< unsigned long >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< unsigned long >::difference_type >(val3);
   {
     std::vector< unsigned long,std::allocator< unsigned long > > *ptr = (std::vector< unsigned long,std::allocator< unsigned long > > *)0;
     res4 = swig::asptr(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_longinteger_t___setslice__" "', argument " "4"" of type '" "std::vector< unsigned long,std::allocator< unsigned long > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_longinteger_T___setslice__" "', argument " "4"" of type '" "std::vector< unsigned long,std::allocator< unsigned long > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_longinteger_t___setslice__" "', argument " "4"" of type '" "std::vector< unsigned long,std::allocator< unsigned long > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_longinteger_T___setslice__" "', argument " "4"" of type '" "std::vector< unsigned long,std::allocator< unsigned long > > const &""'"); 
     }
     arg4 = ptr;
   }
@@ -15695,13 +15695,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___setslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___setslice__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_t___setslice__", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_T___setslice__", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -15718,7 +15718,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setslice__(PyObject *self, PyO
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_longinteger_t___setslice____SWIG_0(self, argc, argv);
+          return _wrap_vector_longinteger_T___setslice____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -15741,7 +15741,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setslice__(PyObject *self, PyO
           int res = swig::asptr(argv[3], (std::vector< unsigned long,std::allocator< unsigned long > >**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vector_longinteger_t___setslice____SWIG_1(self, argc, argv);
+            return _wrap_vector_longinteger_T___setslice____SWIG_1(self, argc, argv);
           }
         }
       }
@@ -15749,7 +15749,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setslice__(PyObject *self, PyO
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_t___setslice__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_T___setslice__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< unsigned long >::__setslice__(std::vector< unsigned long >::difference_type,std::vector< unsigned long >::difference_type)\n"
     "    std::vector< unsigned long >::__setslice__(std::vector< unsigned long >::difference_type,std::vector< unsigned long >::difference_type,std::vector< unsigned long,std::allocator< unsigned long > > const &)\n");
@@ -15757,7 +15757,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___delslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___delslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::difference_type arg2 ;
@@ -15771,20 +15771,20 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___delslice__(PyObject *self, PyO
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_t___delslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_T___delslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___delslice__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___delslice__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t___delslice__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T___delslice__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< unsigned long >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_t___delslice__" "', argument " "3"" of type '" "std::vector< unsigned long >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_T___delslice__" "', argument " "3"" of type '" "std::vector< unsigned long >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< unsigned long >::difference_type >(val3);
   try {
@@ -15801,7 +15801,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::difference_type arg2 ;
@@ -15814,12 +15814,12 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___delitem____SWIG_0(PyObject *se
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___delitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___delitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t___delitem__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T___delitem__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< unsigned long >::difference_type >(val2);
   try {
@@ -15836,7 +15836,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -15848,12 +15848,12 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___getitem____SWIG_0(PyObject *se
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___getitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___getitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -15871,7 +15871,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -15884,12 +15884,12 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setitem____SWIG_0(PyObject *se
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___setitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___setitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -15897,10 +15897,10 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setitem____SWIG_0(PyObject *se
     std::vector< unsigned long,std::allocator< unsigned long > > *ptr = (std::vector< unsigned long,std::allocator< unsigned long > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_longinteger_t___setitem__" "', argument " "3"" of type '" "std::vector< unsigned long,std::allocator< unsigned long > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_longinteger_T___setitem__" "', argument " "3"" of type '" "std::vector< unsigned long,std::allocator< unsigned long > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_longinteger_t___setitem__" "', argument " "3"" of type '" "std::vector< unsigned long,std::allocator< unsigned long > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_longinteger_T___setitem__" "', argument " "3"" of type '" "std::vector< unsigned long,std::allocator< unsigned long > > const &""'"); 
     }
     arg3 = ptr;
   }
@@ -15920,7 +15920,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -15931,12 +15931,12 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setitem____SWIG_1(PyObject *se
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___setitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___setitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -15954,7 +15954,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -15965,12 +15965,12 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___delitem____SWIG_1(PyObject *se
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___delitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___delitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -15988,13 +15988,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___delitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___delitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_t___delitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_T___delitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -16005,7 +16005,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___delitem__(PyObject *self, PyOb
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_longinteger_t___delitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_longinteger_T___delitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -16019,13 +16019,13 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___delitem__(PyObject *self, PyOb
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_longinteger_t___delitem____SWIG_0(self, argc, argv);
+        return _wrap_vector_longinteger_T___delitem____SWIG_0(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_t___delitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_T___delitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< unsigned long >::__delitem__(std::vector< unsigned long >::difference_type)\n"
     "    std::vector< unsigned long >::__delitem__(SWIGPY_SLICEOBJECT *)\n");
@@ -16033,7 +16033,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::difference_type arg2 ;
@@ -16047,12 +16047,12 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___getitem____SWIG_1(PyObject *se
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___getitem__" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___getitem__" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t___getitem__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T___getitem__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< unsigned long >::difference_type >(val2);
   try {
@@ -16068,13 +16068,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___getitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___getitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_t___getitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_T___getitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -16085,7 +16085,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___getitem__(PyObject *self, PyOb
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_longinteger_t___getitem____SWIG_0(self, argc, argv);
+        return _wrap_vector_longinteger_T___getitem____SWIG_0(self, argc, argv);
       }
     }
   }
@@ -16099,13 +16099,13 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___getitem__(PyObject *self, PyOb
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_longinteger_t___getitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_longinteger_T___getitem____SWIG_1(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_t___getitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_T___getitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< unsigned long >::__getitem__(SWIGPY_SLICEOBJECT *)\n"
     "    std::vector< unsigned long >::__getitem__(std::vector< unsigned long >::difference_type) const\n");
@@ -16113,7 +16113,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::difference_type arg2 ;
@@ -16130,17 +16130,17 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setitem____SWIG_2(PyObject *se
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___setitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___setitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t___setitem__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T___setitem__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< unsigned long >::difference_type >(val2);
   ecode3 = SWIG_AsVal_unsigned_SS_long(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_t___setitem__" "', argument " "3"" of type '" "std::vector< unsigned long >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_T___setitem__" "', argument " "3"" of type '" "std::vector< unsigned long >::value_type""'");
   } 
   temp3 = static_cast< std::vector< unsigned long >::value_type >(val3);
   arg3 = &temp3;
@@ -16156,13 +16156,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___setitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___setitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_t___setitem__", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_T___setitem__", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -16173,7 +16173,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setitem__(PyObject *self, PyOb
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_longinteger_t___setitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_longinteger_T___setitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -16189,7 +16189,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setitem__(PyObject *self, PyOb
         int res = swig::asptr(argv[2], (std::vector< unsigned long,std::allocator< unsigned long > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vector_longinteger_t___setitem____SWIG_0(self, argc, argv);
+          return _wrap_vector_longinteger_T___setitem____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -16209,14 +16209,14 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setitem__(PyObject *self, PyOb
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_longinteger_t___setitem____SWIG_2(self, argc, argv);
+          return _wrap_vector_longinteger_T___setitem____SWIG_2(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_t___setitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_T___setitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< unsigned long >::__setitem__(SWIGPY_SLICEOBJECT *,std::vector< unsigned long,std::allocator< unsigned long > > const &)\n"
     "    std::vector< unsigned long >::__setitem__(SWIGPY_SLICEOBJECT *)\n"
@@ -16225,7 +16225,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_pop(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_pop(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -16238,7 +16238,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_pop(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_pop" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_pop" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   try {
@@ -16253,7 +16253,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_append(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_append(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::value_type *arg2 = 0 ;
@@ -16265,15 +16265,15 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_append(PyObject *self, PyObject
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_t_append", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_T_append", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_append" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_append" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_unsigned_SS_long(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t_append" "', argument " "2"" of type '" "std::vector< unsigned long >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T_append" "', argument " "2"" of type '" "std::vector< unsigned long >::value_type""'");
   } 
   temp2 = static_cast< std::vector< unsigned long >::value_type >(val2);
   arg2 = &temp2;
@@ -16285,7 +16285,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_longinteger_t__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
+SWIGINTERN PyObject *_wrap_new_vector_longinteger_T__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *result = 0 ;
   
@@ -16299,7 +16299,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_longinteger_t__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_longinteger_T__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = 0 ;
   int res1 = SWIG_OLDOBJ ;
@@ -16311,10 +16311,10 @@ SWIGINTERN PyObject *_wrap_new_vector_longinteger_t__SWIG_1(PyObject *self, Py_s
     std::vector< unsigned long,std::allocator< unsigned long > > *ptr = (std::vector< unsigned long,std::allocator< unsigned long > > *)0;
     res1 = swig::asptr(swig_obj[0], &ptr);
     if (!SWIG_IsOK(res1)) {
-      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vector_longinteger_t" "', argument " "1"" of type '" "std::vector< unsigned long > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vector_longinteger_T" "', argument " "1"" of type '" "std::vector< unsigned long > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_longinteger_t" "', argument " "1"" of type '" "std::vector< unsigned long > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_longinteger_T" "', argument " "1"" of type '" "std::vector< unsigned long > const &""'"); 
     }
     arg1 = ptr;
   }
@@ -16328,7 +16328,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_empty(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_empty(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -16341,7 +16341,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_empty(PyObject *self, PyObject *
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_empty" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_empty" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = (bool)((std::vector< unsigned long > const *)arg1)->empty();
@@ -16352,7 +16352,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_size(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_size(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -16365,7 +16365,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_size(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_size" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_size" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = ((std::vector< unsigned long > const *)arg1)->size();
@@ -16376,7 +16376,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_swap(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_swap(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long > *arg2 = 0 ;
@@ -16387,18 +16387,18 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_swap(PyObject *self, PyObject *a
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_t_swap", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_T_swap", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_swap" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_swap" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], &argp2, SWIGTYPE_p_std__vectorT_unsigned_long_t,  0 );
   if (!SWIG_IsOK(res2)) {
-    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_longinteger_t_swap" "', argument " "2"" of type '" "std::vector< unsigned long > &""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_longinteger_T_swap" "', argument " "2"" of type '" "std::vector< unsigned long > &""'"); 
   }
   if (!argp2) {
-    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_longinteger_t_swap" "', argument " "2"" of type '" "std::vector< unsigned long > &""'"); 
+    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_longinteger_T_swap" "', argument " "2"" of type '" "std::vector< unsigned long > &""'"); 
   }
   arg2 = reinterpret_cast< std::vector< unsigned long > * >(argp2);
   (arg1)->swap(*arg2);
@@ -16409,7 +16409,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_begin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_begin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -16422,7 +16422,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_begin(PyObject *self, PyObject *
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_begin" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_begin" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = (arg1)->begin();
@@ -16434,7 +16434,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_end(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_end(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -16447,7 +16447,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_end(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_end" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_end" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = (arg1)->end();
@@ -16459,7 +16459,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_rbegin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_rbegin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -16472,7 +16472,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_rbegin(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_rbegin" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_rbegin" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = (arg1)->rbegin();
@@ -16484,7 +16484,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_rend(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_rend(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -16497,7 +16497,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_rend(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_rend" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_rend" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = (arg1)->rend();
@@ -16509,7 +16509,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_clear(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_clear(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -16521,7 +16521,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_clear(PyObject *self, PyObject *
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_clear" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_clear" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   (arg1)->clear();
@@ -16532,7 +16532,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_get_allocator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_get_allocator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -16545,7 +16545,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_get_allocator(PyObject *self, Py
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_get_allocator" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_get_allocator" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = ((std::vector< unsigned long > const *)arg1)->get_allocator();
@@ -16556,7 +16556,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_longinteger_t__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_longinteger_T__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long >::size_type arg1 ;
   size_t val1 ;
@@ -16567,7 +16567,7 @@ SWIGINTERN PyObject *_wrap_new_vector_longinteger_t__SWIG_2(PyObject *self, Py_s
   if ((nobjs < 1) || (nobjs > 1)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_longinteger_t" "', argument " "1"" of type '" "std::vector< unsigned long >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_longinteger_T" "', argument " "1"" of type '" "std::vector< unsigned long >::size_type""'");
   } 
   arg1 = static_cast< std::vector< unsigned long >::size_type >(val1);
   result = (std::vector< unsigned long > *)new std::vector< unsigned long >(arg1);
@@ -16578,7 +16578,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_pop_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_pop_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -16590,7 +16590,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_pop_back(PyObject *self, PyObjec
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_pop_back" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_pop_back" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   (arg1)->pop_back();
@@ -16601,7 +16601,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::size_type arg2 ;
@@ -16614,12 +16614,12 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_resize__SWIG_0(PyObject *self, P
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_resize" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_resize" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t_resize" "', argument " "2"" of type '" "std::vector< unsigned long >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T_resize" "', argument " "2"" of type '" "std::vector< unsigned long >::size_type""'");
   } 
   arg2 = static_cast< std::vector< unsigned long >::size_type >(val2);
   (arg1)->resize(arg2);
@@ -16630,7 +16630,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::iterator arg2 ;
@@ -16644,18 +16644,18 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_erase__SWIG_0(PyObject *self, Py
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_erase" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_erase" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t_erase" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T_erase" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t_erase" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T_erase" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
     }
   }
   result = std_vector_Sl_unsigned_SS_long_Sg__erase__SWIG_0(arg1,SWIG_STD_MOVE(arg2));
@@ -16667,7 +16667,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::iterator arg2 ;
@@ -16684,29 +16684,29 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_erase__SWIG_1(PyObject *self, Py
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_erase" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_erase" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t_erase" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T_erase" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t_erase" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T_erase" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
     }
   }
   res3 = SWIG_ConvertPtr(swig_obj[2], SWIG_as_voidptrptr(&iter3), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res3) || !iter3) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t_erase" "', argument " "3"" of type '" "std::vector< unsigned long >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T_erase" "', argument " "3"" of type '" "std::vector< unsigned long >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *>(iter3);
     if (iter_t) {
       arg3 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t_erase" "', argument " "3"" of type '" "std::vector< unsigned long >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T_erase" "', argument " "3"" of type '" "std::vector< unsigned long >::iterator""'");
     }
   }
   result = std_vector_Sl_unsigned_SS_long_Sg__erase__SWIG_1(arg1,SWIG_STD_MOVE(arg2),SWIG_STD_MOVE(arg3));
@@ -16718,13 +16718,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_erase(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_erase(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_t_erase", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_T_erase", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -16735,7 +16735,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_erase(PyObject *self, PyObject *
       int res = SWIG_ConvertPtr(argv[1], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
       _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *>(iter) != 0));
       if (_v) {
-        return _wrap_vector_longinteger_t_erase__SWIG_0(self, argc, argv);
+        return _wrap_vector_longinteger_T_erase__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -16752,14 +16752,14 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_erase(PyObject *self, PyObject *
         int res = SWIG_ConvertPtr(argv[2], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
         _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *>(iter) != 0));
         if (_v) {
-          return _wrap_vector_longinteger_t_erase__SWIG_1(self, argc, argv);
+          return _wrap_vector_longinteger_T_erase__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_t_erase'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_T_erase'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< unsigned long >::erase(std::vector< unsigned long >::iterator)\n"
     "    std::vector< unsigned long >::erase(std::vector< unsigned long >::iterator,std::vector< unsigned long >::iterator)\n");
@@ -16767,7 +16767,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_longinteger_t__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_longinteger_T__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long >::size_type arg1 ;
   std::vector< unsigned long >::value_type *arg2 = 0 ;
@@ -16782,12 +16782,12 @@ SWIGINTERN PyObject *_wrap_new_vector_longinteger_t__SWIG_3(PyObject *self, Py_s
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_longinteger_t" "', argument " "1"" of type '" "std::vector< unsigned long >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_longinteger_T" "', argument " "1"" of type '" "std::vector< unsigned long >::size_type""'");
   } 
   arg1 = static_cast< std::vector< unsigned long >::size_type >(val1);
   ecode2 = SWIG_AsVal_unsigned_SS_long(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "new_vector_longinteger_t" "', argument " "2"" of type '" "std::vector< unsigned long >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "new_vector_longinteger_T" "', argument " "2"" of type '" "std::vector< unsigned long >::value_type""'");
   } 
   temp2 = static_cast< std::vector< unsigned long >::value_type >(val2);
   arg2 = &temp2;
@@ -16799,16 +16799,16 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_longinteger_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_new_vector_longinteger_T(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vector_longinteger_t", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vector_longinteger_T", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 0) {
-    return _wrap_new_vector_longinteger_t__SWIG_0(self, argc, argv);
+    return _wrap_new_vector_longinteger_T__SWIG_0(self, argc, argv);
   }
   if (argc == 1) {
     int _v = 0;
@@ -16817,7 +16817,7 @@ SWIGINTERN PyObject *_wrap_new_vector_longinteger_t(PyObject *self, PyObject *ar
       _v = SWIG_CheckState(res);
     }
     if (_v) {
-      return _wrap_new_vector_longinteger_t__SWIG_2(self, argc, argv);
+      return _wrap_new_vector_longinteger_T__SWIG_2(self, argc, argv);
     }
   }
   if (argc == 1) {
@@ -16825,7 +16825,7 @@ SWIGINTERN PyObject *_wrap_new_vector_longinteger_t(PyObject *self, PyObject *ar
     int res = swig::asptr(argv[0], (std::vector< unsigned long,std::allocator< unsigned long > >**)(0));
     _v = SWIG_CheckState(res);
     if (_v) {
-      return _wrap_new_vector_longinteger_t__SWIG_1(self, argc, argv);
+      return _wrap_new_vector_longinteger_T__SWIG_1(self, argc, argv);
     }
   }
   if (argc == 2) {
@@ -16840,13 +16840,13 @@ SWIGINTERN PyObject *_wrap_new_vector_longinteger_t(PyObject *self, PyObject *ar
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_new_vector_longinteger_t__SWIG_3(self, argc, argv);
+        return _wrap_new_vector_longinteger_T__SWIG_3(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vector_longinteger_t'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vector_longinteger_T'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< unsigned long >::vector()\n"
     "    std::vector< unsigned long >::vector(std::vector< unsigned long > const &)\n"
@@ -16856,7 +16856,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_push_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_push_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::value_type *arg2 = 0 ;
@@ -16868,15 +16868,15 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_push_back(PyObject *self, PyObje
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_t_push_back", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_T_push_back", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_push_back" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_push_back" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_unsigned_SS_long(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t_push_back" "', argument " "2"" of type '" "std::vector< unsigned long >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T_push_back" "', argument " "2"" of type '" "std::vector< unsigned long >::value_type""'");
   } 
   temp2 = static_cast< std::vector< unsigned long >::value_type >(val2);
   arg2 = &temp2;
@@ -16888,7 +16888,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_front(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_front(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -16901,7 +16901,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_front(PyObject *self, PyObject *
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_front" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_front" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = (std::vector< unsigned long >::value_type *) &((std::vector< unsigned long > const *)arg1)->front();
@@ -16913,7 +16913,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -16926,7 +16926,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_back(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_back" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_back" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = (std::vector< unsigned long >::value_type *) &((std::vector< unsigned long > const *)arg1)->back();
@@ -16938,7 +16938,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_assign(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_assign(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::size_type arg2 ;
@@ -16953,20 +16953,20 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_assign(PyObject *self, PyObject
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_t_assign", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_T_assign", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_assign" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_assign" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t_assign" "', argument " "2"" of type '" "std::vector< unsigned long >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T_assign" "', argument " "2"" of type '" "std::vector< unsigned long >::size_type""'");
   } 
   arg2 = static_cast< std::vector< unsigned long >::size_type >(val2);
   ecode3 = SWIG_AsVal_unsigned_SS_long(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_t_assign" "', argument " "3"" of type '" "std::vector< unsigned long >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_T_assign" "', argument " "3"" of type '" "std::vector< unsigned long >::value_type""'");
   } 
   temp3 = static_cast< std::vector< unsigned long >::value_type >(val3);
   arg3 = &temp3;
@@ -16978,7 +16978,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::size_type arg2 ;
@@ -16995,17 +16995,17 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_resize__SWIG_1(PyObject *self, P
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_resize" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_resize" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t_resize" "', argument " "2"" of type '" "std::vector< unsigned long >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T_resize" "', argument " "2"" of type '" "std::vector< unsigned long >::size_type""'");
   } 
   arg2 = static_cast< std::vector< unsigned long >::size_type >(val2);
   ecode3 = SWIG_AsVal_unsigned_SS_long(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_t_resize" "', argument " "3"" of type '" "std::vector< unsigned long >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_T_resize" "', argument " "3"" of type '" "std::vector< unsigned long >::value_type""'");
   } 
   temp3 = static_cast< std::vector< unsigned long >::value_type >(val3);
   arg3 = &temp3;
@@ -17017,13 +17017,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_resize(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_resize(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_t_resize", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_T_resize", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -17035,7 +17035,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_resize(PyObject *self, PyObject
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_longinteger_t_resize__SWIG_0(self, argc, argv);
+        return _wrap_vector_longinteger_T_resize__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -17054,14 +17054,14 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_resize(PyObject *self, PyObject
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_longinteger_t_resize__SWIG_1(self, argc, argv);
+          return _wrap_vector_longinteger_T_resize__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_t_resize'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_T_resize'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< unsigned long >::resize(std::vector< unsigned long >::size_type)\n"
     "    std::vector< unsigned long >::resize(std::vector< unsigned long >::size_type,std::vector< unsigned long >::value_type const &)\n");
@@ -17069,7 +17069,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::iterator arg2 ;
@@ -17087,23 +17087,23 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_insert__SWIG_0(PyObject *self, P
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_insert" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_insert" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t_insert" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T_insert" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t_insert" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T_insert" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_unsigned_SS_long(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_t_insert" "', argument " "3"" of type '" "std::vector< unsigned long >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_T_insert" "', argument " "3"" of type '" "std::vector< unsigned long >::value_type""'");
   } 
   temp3 = static_cast< std::vector< unsigned long >::value_type >(val3);
   arg3 = &temp3;
@@ -17116,7 +17116,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::iterator arg2 ;
@@ -17136,28 +17136,28 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_insert__SWIG_1(PyObject *self, P
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_insert" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_insert" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t_insert" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T_insert" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t_insert" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T_insert" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_size_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_t_insert" "', argument " "3"" of type '" "std::vector< unsigned long >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_T_insert" "', argument " "3"" of type '" "std::vector< unsigned long >::size_type""'");
   } 
   arg3 = static_cast< std::vector< unsigned long >::size_type >(val3);
   ecode4 = SWIG_AsVal_unsigned_SS_long(swig_obj[3], &val4);
   if (!SWIG_IsOK(ecode4)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode4), "in method '" "vector_longinteger_t_insert" "', argument " "4"" of type '" "std::vector< unsigned long >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode4), "in method '" "vector_longinteger_T_insert" "', argument " "4"" of type '" "std::vector< unsigned long >::value_type""'");
   } 
   temp4 = static_cast< std::vector< unsigned long >::value_type >(val4);
   arg4 = &temp4;
@@ -17169,13 +17169,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_insert(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_insert(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_t_insert", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_T_insert", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -17191,7 +17191,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_insert(PyObject *self, PyObject
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_longinteger_t_insert__SWIG_0(self, argc, argv);
+          return _wrap_vector_longinteger_T_insert__SWIG_0(self, argc, argv);
         }
       }
     }
@@ -17215,7 +17215,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_insert(PyObject *self, PyObject
             _v = SWIG_CheckState(res);
           }
           if (_v) {
-            return _wrap_vector_longinteger_t_insert__SWIG_1(self, argc, argv);
+            return _wrap_vector_longinteger_T_insert__SWIG_1(self, argc, argv);
           }
         }
       }
@@ -17223,7 +17223,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_insert(PyObject *self, PyObject
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_t_insert'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_T_insert'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< unsigned long >::insert(std::vector< unsigned long >::iterator,std::vector< unsigned long >::value_type const &)\n"
     "    std::vector< unsigned long >::insert(std::vector< unsigned long >::iterator,std::vector< unsigned long >::size_type,std::vector< unsigned long >::value_type const &)\n");
@@ -17231,7 +17231,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_reserve(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_reserve(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::size_type arg2 ;
@@ -17242,15 +17242,15 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_reserve(PyObject *self, PyObject
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_t_reserve", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_T_reserve", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_reserve" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_reserve" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t_reserve" "', argument " "2"" of type '" "std::vector< unsigned long >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T_reserve" "', argument " "2"" of type '" "std::vector< unsigned long >::size_type""'");
   } 
   arg2 = static_cast< std::vector< unsigned long >::size_type >(val2);
   (arg1)->reserve(arg2);
@@ -17261,7 +17261,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_capacity(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_capacity(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -17274,7 +17274,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_capacity(PyObject *self, PyObjec
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_capacity" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_capacity" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = ((std::vector< unsigned long > const *)arg1)->capacity();
@@ -17285,7 +17285,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_delete_vector_longinteger_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_delete_vector_longinteger_T(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -17297,7 +17297,7 @@ SWIGINTERN PyObject *_wrap_delete_vector_longinteger_t(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, SWIG_POINTER_DISOWN |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vector_longinteger_t" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vector_longinteger_T" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   {
@@ -17318,18 +17318,18 @@ fail:
 }
 
 
-SWIGINTERN PyObject *vector_longinteger_t_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vector_longinteger_T_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   PyObject *obj;
   if (!SWIG_Python_UnpackTuple(args, "swigregister", 1, 1, &obj)) return NULL;
   SWIG_TypeNewClientData(SWIGTYPE_p_std__vectorT_unsigned_long_t, SWIG_NewClientData(obj));
   return SWIG_Py_Void();
 }
 
-SWIGINTERN PyObject *vector_longinteger_t_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vector_longinteger_T_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   return SWIG_Python_InitShadowInstance(args);
 }
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_iterator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_iterator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   PyObject **arg2 = (PyObject **) 0 ;
@@ -17344,7 +17344,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_iterator(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_iterator" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_iterator" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = (swig::SwigPyIterator *)std_vector_Sl_std_complex_Sl_double_Sg__Sg__iterator(arg1,arg2);
@@ -17355,7 +17355,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___nonzero__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___nonzero__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -17368,7 +17368,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___nonzero__(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___nonzero__" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___nonzero__" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = (bool)std_vector_Sl_std_complex_Sl_double_Sg__Sg____nonzero__((std::vector< std::complex< double > > const *)arg1);
@@ -17379,7 +17379,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___bool__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___bool__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -17392,7 +17392,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___bool__(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___bool__" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___bool__" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = (bool)std_vector_Sl_std_complex_Sl_double_Sg__Sg____bool__((std::vector< std::complex< double > > const *)arg1);
@@ -17403,7 +17403,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___len__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___len__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -17416,7 +17416,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___len__(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___len__" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___len__" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = std_vector_Sl_std_complex_Sl_double_Sg__Sg____len__((std::vector< std::complex< double > > const *)arg1);
@@ -17427,7 +17427,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___getslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___getslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::difference_type arg2 ;
@@ -17442,20 +17442,20 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___getslice__(PyObject *self, PyObjec
   std::vector< std::complex< double >,std::allocator< std::complex< double > > > *result = 0 ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_complex_t___getslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_complex_T___getslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___getslice__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___getslice__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t___getslice__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T___getslice__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::complex< double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_t___getslice__" "', argument " "3"" of type '" "std::vector< std::complex< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_T___getslice__" "', argument " "3"" of type '" "std::vector< std::complex< double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::complex< double > >::difference_type >(val3);
   try {
@@ -17472,7 +17472,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::difference_type arg2 ;
@@ -17488,17 +17488,17 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setslice____SWIG_0(PyObject *self,
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___setslice__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___setslice__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t___setslice__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T___setslice__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::complex< double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_t___setslice__" "', argument " "3"" of type '" "std::vector< std::complex< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_T___setslice__" "', argument " "3"" of type '" "std::vector< std::complex< double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::complex< double > >::difference_type >(val3);
   try {
@@ -17515,7 +17515,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::difference_type arg2 ;
@@ -17533,27 +17533,27 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setslice____SWIG_1(PyObject *self,
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___setslice__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___setslice__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t___setslice__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T___setslice__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::complex< double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_t___setslice__" "', argument " "3"" of type '" "std::vector< std::complex< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_T___setslice__" "', argument " "3"" of type '" "std::vector< std::complex< double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::complex< double > >::difference_type >(val3);
   {
     std::vector< std::complex< double >,std::allocator< std::complex< double > > > *ptr = (std::vector< std::complex< double >,std::allocator< std::complex< double > > > *)0;
     res4 = swig::asptr(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_complex_t___setslice__" "', argument " "4"" of type '" "std::vector< std::complex< double >,std::allocator< std::complex< double > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_complex_T___setslice__" "', argument " "4"" of type '" "std::vector< std::complex< double >,std::allocator< std::complex< double > > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_complex_t___setslice__" "', argument " "4"" of type '" "std::vector< std::complex< double >,std::allocator< std::complex< double > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_complex_T___setslice__" "', argument " "4"" of type '" "std::vector< std::complex< double >,std::allocator< std::complex< double > > > const &""'"); 
     }
     arg4 = ptr;
   }
@@ -17573,13 +17573,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___setslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___setslice__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_t___setslice__", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_T___setslice__", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -17596,7 +17596,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setslice__(PyObject *self, PyObjec
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_complex_t___setslice____SWIG_0(self, argc, argv);
+          return _wrap_vector_complex_T___setslice____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -17619,7 +17619,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setslice__(PyObject *self, PyObjec
           int res = swig::asptr(argv[3], (std::vector< std::complex< double >,std::allocator< std::complex< double > > >**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vector_complex_t___setslice____SWIG_1(self, argc, argv);
+            return _wrap_vector_complex_T___setslice____SWIG_1(self, argc, argv);
           }
         }
       }
@@ -17627,7 +17627,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setslice__(PyObject *self, PyObjec
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_t___setslice__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_T___setslice__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::complex< double > >::__setslice__(std::vector< std::complex< double > >::difference_type,std::vector< std::complex< double > >::difference_type)\n"
     "    std::vector< std::complex< double > >::__setslice__(std::vector< std::complex< double > >::difference_type,std::vector< std::complex< double > >::difference_type,std::vector< std::complex< double >,std::allocator< std::complex< double > > > const &)\n");
@@ -17635,7 +17635,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___delslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___delslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::difference_type arg2 ;
@@ -17649,20 +17649,20 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___delslice__(PyObject *self, PyObjec
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_complex_t___delslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_complex_T___delslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___delslice__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___delslice__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t___delslice__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T___delslice__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::complex< double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_t___delslice__" "', argument " "3"" of type '" "std::vector< std::complex< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_T___delslice__" "', argument " "3"" of type '" "std::vector< std::complex< double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::complex< double > >::difference_type >(val3);
   try {
@@ -17679,7 +17679,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::difference_type arg2 ;
@@ -17692,12 +17692,12 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___delitem____SWIG_0(PyObject *self,
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___delitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___delitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t___delitem__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T___delitem__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::complex< double > >::difference_type >(val2);
   try {
@@ -17714,7 +17714,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -17726,12 +17726,12 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___getitem____SWIG_0(PyObject *self,
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___getitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___getitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -17749,7 +17749,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -17762,12 +17762,12 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setitem____SWIG_0(PyObject *self,
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___setitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___setitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -17775,10 +17775,10 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setitem____SWIG_0(PyObject *self,
     std::vector< std::complex< double >,std::allocator< std::complex< double > > > *ptr = (std::vector< std::complex< double >,std::allocator< std::complex< double > > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_complex_t___setitem__" "', argument " "3"" of type '" "std::vector< std::complex< double >,std::allocator< std::complex< double > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_complex_T___setitem__" "', argument " "3"" of type '" "std::vector< std::complex< double >,std::allocator< std::complex< double > > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_complex_t___setitem__" "', argument " "3"" of type '" "std::vector< std::complex< double >,std::allocator< std::complex< double > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_complex_T___setitem__" "', argument " "3"" of type '" "std::vector< std::complex< double >,std::allocator< std::complex< double > > > const &""'"); 
     }
     arg3 = ptr;
   }
@@ -17798,7 +17798,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -17809,12 +17809,12 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setitem____SWIG_1(PyObject *self,
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___setitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___setitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -17832,7 +17832,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -17843,12 +17843,12 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___delitem____SWIG_1(PyObject *self,
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___delitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___delitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -17866,13 +17866,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___delitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___delitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_t___delitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_T___delitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -17883,7 +17883,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___delitem__(PyObject *self, PyObject
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_complex_t___delitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_complex_T___delitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -17897,13 +17897,13 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___delitem__(PyObject *self, PyObject
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_complex_t___delitem____SWIG_0(self, argc, argv);
+        return _wrap_vector_complex_T___delitem____SWIG_0(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_t___delitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_T___delitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::complex< double > >::__delitem__(std::vector< std::complex< double > >::difference_type)\n"
     "    std::vector< std::complex< double > >::__delitem__(SWIGPY_SLICEOBJECT *)\n");
@@ -17911,7 +17911,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::difference_type arg2 ;
@@ -17925,12 +17925,12 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___getitem____SWIG_1(PyObject *self,
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___getitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___getitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t___getitem__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T___getitem__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::complex< double > >::difference_type >(val2);
   try {
@@ -17946,13 +17946,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___getitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___getitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_t___getitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_T___getitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -17963,7 +17963,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___getitem__(PyObject *self, PyObject
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_complex_t___getitem____SWIG_0(self, argc, argv);
+        return _wrap_vector_complex_T___getitem____SWIG_0(self, argc, argv);
       }
     }
   }
@@ -17977,13 +17977,13 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___getitem__(PyObject *self, PyObject
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_complex_t___getitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_complex_T___getitem____SWIG_1(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_t___getitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_T___getitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::complex< double > >::__getitem__(SWIGPY_SLICEOBJECT *)\n"
     "    std::vector< std::complex< double > >::__getitem__(std::vector< std::complex< double > >::difference_type) const\n");
@@ -17991,7 +17991,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::difference_type arg2 ;
@@ -18008,17 +18008,17 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setitem____SWIG_2(PyObject *self,
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___setitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___setitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t___setitem__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T___setitem__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::complex< double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_std_complex_Sl_double_Sg_(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_t___setitem__" "', argument " "3"" of type '" "std::vector< std::complex< double > >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_T___setitem__" "', argument " "3"" of type '" "std::vector< std::complex< double > >::value_type""'");
   } 
   temp3 = static_cast< std::vector< std::complex< double > >::value_type >(val3);
   arg3 = &temp3;
@@ -18034,13 +18034,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___setitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___setitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_t___setitem__", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_T___setitem__", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -18051,7 +18051,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setitem__(PyObject *self, PyObject
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_complex_t___setitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_complex_T___setitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -18067,7 +18067,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setitem__(PyObject *self, PyObject
         int res = swig::asptr(argv[2], (std::vector< std::complex< double >,std::allocator< std::complex< double > > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vector_complex_t___setitem____SWIG_0(self, argc, argv);
+          return _wrap_vector_complex_T___setitem____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -18087,14 +18087,14 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setitem__(PyObject *self, PyObject
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_complex_t___setitem____SWIG_2(self, argc, argv);
+          return _wrap_vector_complex_T___setitem____SWIG_2(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_t___setitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_T___setitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::complex< double > >::__setitem__(SWIGPY_SLICEOBJECT *,std::vector< std::complex< double >,std::allocator< std::complex< double > > > const &)\n"
     "    std::vector< std::complex< double > >::__setitem__(SWIGPY_SLICEOBJECT *)\n"
@@ -18103,7 +18103,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_pop(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_pop(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -18116,7 +18116,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_pop(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_pop" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_pop" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   try {
@@ -18131,7 +18131,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_append(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_append(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::value_type *arg2 = 0 ;
@@ -18143,15 +18143,15 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_append(PyObject *self, PyObject *arg
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_complex_t_append", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_complex_T_append", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_append" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_append" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_std_complex_Sl_double_Sg_(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t_append" "', argument " "2"" of type '" "std::vector< std::complex< double > >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T_append" "', argument " "2"" of type '" "std::vector< std::complex< double > >::value_type""'");
   } 
   temp2 = static_cast< std::vector< std::complex< double > >::value_type >(val2);
   arg2 = &temp2;
@@ -18163,7 +18163,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_complex_t__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
+SWIGINTERN PyObject *_wrap_new_vector_complex_T__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *result = 0 ;
   
@@ -18177,7 +18177,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_complex_t__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_complex_T__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = 0 ;
   int res1 = SWIG_OLDOBJ ;
@@ -18189,10 +18189,10 @@ SWIGINTERN PyObject *_wrap_new_vector_complex_t__SWIG_1(PyObject *self, Py_ssize
     std::vector< std::complex< double >,std::allocator< std::complex< double > > > *ptr = (std::vector< std::complex< double >,std::allocator< std::complex< double > > > *)0;
     res1 = swig::asptr(swig_obj[0], &ptr);
     if (!SWIG_IsOK(res1)) {
-      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vector_complex_t" "', argument " "1"" of type '" "std::vector< std::complex< double > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vector_complex_T" "', argument " "1"" of type '" "std::vector< std::complex< double > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_complex_t" "', argument " "1"" of type '" "std::vector< std::complex< double > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_complex_T" "', argument " "1"" of type '" "std::vector< std::complex< double > > const &""'"); 
     }
     arg1 = ptr;
   }
@@ -18206,7 +18206,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_empty(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_empty(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -18219,7 +18219,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_empty(PyObject *self, PyObject *args
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_empty" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_empty" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = (bool)((std::vector< std::complex< double > > const *)arg1)->empty();
@@ -18230,7 +18230,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_size(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_size(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -18243,7 +18243,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_size(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_size" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_size" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = ((std::vector< std::complex< double > > const *)arg1)->size();
@@ -18254,7 +18254,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_swap(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_swap(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > > *arg2 = 0 ;
@@ -18265,18 +18265,18 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_swap(PyObject *self, PyObject *args)
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_complex_t_swap", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_complex_T_swap", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_swap" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_swap" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], &argp2, SWIGTYPE_p_std__vectorT_std__complexT_double_t_t,  0 );
   if (!SWIG_IsOK(res2)) {
-    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_complex_t_swap" "', argument " "2"" of type '" "std::vector< std::complex< double > > &""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_complex_T_swap" "', argument " "2"" of type '" "std::vector< std::complex< double > > &""'"); 
   }
   if (!argp2) {
-    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_complex_t_swap" "', argument " "2"" of type '" "std::vector< std::complex< double > > &""'"); 
+    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_complex_T_swap" "', argument " "2"" of type '" "std::vector< std::complex< double > > &""'"); 
   }
   arg2 = reinterpret_cast< std::vector< std::complex< double > > * >(argp2);
   (arg1)->swap(*arg2);
@@ -18287,7 +18287,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_begin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_begin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -18300,7 +18300,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_begin(PyObject *self, PyObject *args
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_begin" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_begin" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = (arg1)->begin();
@@ -18312,7 +18312,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_end(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_end(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -18325,7 +18325,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_end(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_end" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_end" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = (arg1)->end();
@@ -18337,7 +18337,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_rbegin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_rbegin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -18350,7 +18350,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_rbegin(PyObject *self, PyObject *arg
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_rbegin" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_rbegin" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = (arg1)->rbegin();
@@ -18362,7 +18362,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_rend(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_rend(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -18375,7 +18375,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_rend(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_rend" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_rend" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = (arg1)->rend();
@@ -18387,7 +18387,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_clear(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_clear(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -18399,7 +18399,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_clear(PyObject *self, PyObject *args
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_clear" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_clear" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   (arg1)->clear();
@@ -18410,7 +18410,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_get_allocator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_get_allocator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -18423,7 +18423,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_get_allocator(PyObject *self, PyObje
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_get_allocator" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_get_allocator" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = ((std::vector< std::complex< double > > const *)arg1)->get_allocator();
@@ -18434,7 +18434,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_complex_t__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_complex_T__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > >::size_type arg1 ;
   size_t val1 ;
@@ -18445,7 +18445,7 @@ SWIGINTERN PyObject *_wrap_new_vector_complex_t__SWIG_2(PyObject *self, Py_ssize
   if ((nobjs < 1) || (nobjs > 1)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_complex_t" "', argument " "1"" of type '" "std::vector< std::complex< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_complex_T" "', argument " "1"" of type '" "std::vector< std::complex< double > >::size_type""'");
   } 
   arg1 = static_cast< std::vector< std::complex< double > >::size_type >(val1);
   result = (std::vector< std::complex< double > > *)new std::vector< std::complex< double > >(arg1);
@@ -18456,7 +18456,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_pop_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_pop_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -18468,7 +18468,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_pop_back(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_pop_back" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_pop_back" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   (arg1)->pop_back();
@@ -18479,7 +18479,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::size_type arg2 ;
@@ -18492,12 +18492,12 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_resize__SWIG_0(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_resize" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_resize" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t_resize" "', argument " "2"" of type '" "std::vector< std::complex< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T_resize" "', argument " "2"" of type '" "std::vector< std::complex< double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::complex< double > >::size_type >(val2);
   (arg1)->resize(arg2);
@@ -18508,7 +18508,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::iterator arg2 ;
@@ -18522,18 +18522,18 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_erase__SWIG_0(PyObject *self, Py_ssi
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_erase" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_erase" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t_erase" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T_erase" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t_erase" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T_erase" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
     }
   }
   result = std_vector_Sl_std_complex_Sl_double_Sg__Sg__erase__SWIG_0(arg1,SWIG_STD_MOVE(arg2));
@@ -18545,7 +18545,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::iterator arg2 ;
@@ -18562,29 +18562,29 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_erase__SWIG_1(PyObject *self, Py_ssi
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_erase" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_erase" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t_erase" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T_erase" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t_erase" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T_erase" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
     }
   }
   res3 = SWIG_ConvertPtr(swig_obj[2], SWIG_as_voidptrptr(&iter3), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res3) || !iter3) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t_erase" "', argument " "3"" of type '" "std::vector< std::complex< double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T_erase" "', argument " "3"" of type '" "std::vector< std::complex< double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *>(iter3);
     if (iter_t) {
       arg3 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t_erase" "', argument " "3"" of type '" "std::vector< std::complex< double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T_erase" "', argument " "3"" of type '" "std::vector< std::complex< double > >::iterator""'");
     }
   }
   result = std_vector_Sl_std_complex_Sl_double_Sg__Sg__erase__SWIG_1(arg1,SWIG_STD_MOVE(arg2),SWIG_STD_MOVE(arg3));
@@ -18596,13 +18596,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_erase(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_erase(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_t_erase", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_T_erase", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -18613,7 +18613,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_erase(PyObject *self, PyObject *args
       int res = SWIG_ConvertPtr(argv[1], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
       _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *>(iter) != 0));
       if (_v) {
-        return _wrap_vector_complex_t_erase__SWIG_0(self, argc, argv);
+        return _wrap_vector_complex_T_erase__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -18630,14 +18630,14 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_erase(PyObject *self, PyObject *args
         int res = SWIG_ConvertPtr(argv[2], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
         _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *>(iter) != 0));
         if (_v) {
-          return _wrap_vector_complex_t_erase__SWIG_1(self, argc, argv);
+          return _wrap_vector_complex_T_erase__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_t_erase'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_T_erase'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::complex< double > >::erase(std::vector< std::complex< double > >::iterator)\n"
     "    std::vector< std::complex< double > >::erase(std::vector< std::complex< double > >::iterator,std::vector< std::complex< double > >::iterator)\n");
@@ -18645,7 +18645,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_complex_t__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_complex_T__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > >::size_type arg1 ;
   std::vector< std::complex< double > >::value_type *arg2 = 0 ;
@@ -18660,12 +18660,12 @@ SWIGINTERN PyObject *_wrap_new_vector_complex_t__SWIG_3(PyObject *self, Py_ssize
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_complex_t" "', argument " "1"" of type '" "std::vector< std::complex< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_complex_T" "', argument " "1"" of type '" "std::vector< std::complex< double > >::size_type""'");
   } 
   arg1 = static_cast< std::vector< std::complex< double > >::size_type >(val1);
   ecode2 = SWIG_AsVal_std_complex_Sl_double_Sg_(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "new_vector_complex_t" "', argument " "2"" of type '" "std::vector< std::complex< double > >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "new_vector_complex_T" "', argument " "2"" of type '" "std::vector< std::complex< double > >::value_type""'");
   } 
   temp2 = static_cast< std::vector< std::complex< double > >::value_type >(val2);
   arg2 = &temp2;
@@ -18677,16 +18677,16 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_complex_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_new_vector_complex_T(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vector_complex_t", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vector_complex_T", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 0) {
-    return _wrap_new_vector_complex_t__SWIG_0(self, argc, argv);
+    return _wrap_new_vector_complex_T__SWIG_0(self, argc, argv);
   }
   if (argc == 1) {
     int _v = 0;
@@ -18695,7 +18695,7 @@ SWIGINTERN PyObject *_wrap_new_vector_complex_t(PyObject *self, PyObject *args)
       _v = SWIG_CheckState(res);
     }
     if (_v) {
-      return _wrap_new_vector_complex_t__SWIG_2(self, argc, argv);
+      return _wrap_new_vector_complex_T__SWIG_2(self, argc, argv);
     }
   }
   if (argc == 1) {
@@ -18703,7 +18703,7 @@ SWIGINTERN PyObject *_wrap_new_vector_complex_t(PyObject *self, PyObject *args)
     int res = swig::asptr(argv[0], (std::vector< std::complex< double >,std::allocator< std::complex< double > > >**)(0));
     _v = SWIG_CheckState(res);
     if (_v) {
-      return _wrap_new_vector_complex_t__SWIG_1(self, argc, argv);
+      return _wrap_new_vector_complex_T__SWIG_1(self, argc, argv);
     }
   }
   if (argc == 2) {
@@ -18718,13 +18718,13 @@ SWIGINTERN PyObject *_wrap_new_vector_complex_t(PyObject *self, PyObject *args)
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_new_vector_complex_t__SWIG_3(self, argc, argv);
+        return _wrap_new_vector_complex_T__SWIG_3(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vector_complex_t'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vector_complex_T'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::complex< double > >::vector()\n"
     "    std::vector< std::complex< double > >::vector(std::vector< std::complex< double > > const &)\n"
@@ -18734,7 +18734,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_push_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_push_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::value_type *arg2 = 0 ;
@@ -18746,15 +18746,15 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_push_back(PyObject *self, PyObject *
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_complex_t_push_back", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_complex_T_push_back", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_push_back" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_push_back" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_std_complex_Sl_double_Sg_(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t_push_back" "', argument " "2"" of type '" "std::vector< std::complex< double > >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T_push_back" "', argument " "2"" of type '" "std::vector< std::complex< double > >::value_type""'");
   } 
   temp2 = static_cast< std::vector< std::complex< double > >::value_type >(val2);
   arg2 = &temp2;
@@ -18766,7 +18766,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_front(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_front(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -18779,7 +18779,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_front(PyObject *self, PyObject *args
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_front" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_front" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = (std::vector< std::complex< double > >::value_type *) &((std::vector< std::complex< double > > const *)arg1)->front();
@@ -18791,7 +18791,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -18804,7 +18804,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_back(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_back" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_back" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = (std::vector< std::complex< double > >::value_type *) &((std::vector< std::complex< double > > const *)arg1)->back();
@@ -18816,7 +18816,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_assign(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_assign(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::size_type arg2 ;
@@ -18831,20 +18831,20 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_assign(PyObject *self, PyObject *arg
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_complex_t_assign", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_complex_T_assign", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_assign" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_assign" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t_assign" "', argument " "2"" of type '" "std::vector< std::complex< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T_assign" "', argument " "2"" of type '" "std::vector< std::complex< double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::complex< double > >::size_type >(val2);
   ecode3 = SWIG_AsVal_std_complex_Sl_double_Sg_(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_t_assign" "', argument " "3"" of type '" "std::vector< std::complex< double > >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_T_assign" "', argument " "3"" of type '" "std::vector< std::complex< double > >::value_type""'");
   } 
   temp3 = static_cast< std::vector< std::complex< double > >::value_type >(val3);
   arg3 = &temp3;
@@ -18856,7 +18856,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::size_type arg2 ;
@@ -18873,17 +18873,17 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_resize__SWIG_1(PyObject *self, Py_ss
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_resize" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_resize" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t_resize" "', argument " "2"" of type '" "std::vector< std::complex< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T_resize" "', argument " "2"" of type '" "std::vector< std::complex< double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::complex< double > >::size_type >(val2);
   ecode3 = SWIG_AsVal_std_complex_Sl_double_Sg_(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_t_resize" "', argument " "3"" of type '" "std::vector< std::complex< double > >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_T_resize" "', argument " "3"" of type '" "std::vector< std::complex< double > >::value_type""'");
   } 
   temp3 = static_cast< std::vector< std::complex< double > >::value_type >(val3);
   arg3 = &temp3;
@@ -18895,13 +18895,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_resize(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_resize(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_t_resize", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_T_resize", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -18913,7 +18913,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_resize(PyObject *self, PyObject *arg
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_complex_t_resize__SWIG_0(self, argc, argv);
+        return _wrap_vector_complex_T_resize__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -18932,14 +18932,14 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_resize(PyObject *self, PyObject *arg
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_complex_t_resize__SWIG_1(self, argc, argv);
+          return _wrap_vector_complex_T_resize__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_t_resize'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_T_resize'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::complex< double > >::resize(std::vector< std::complex< double > >::size_type)\n"
     "    std::vector< std::complex< double > >::resize(std::vector< std::complex< double > >::size_type,std::vector< std::complex< double > >::value_type const &)\n");
@@ -18947,7 +18947,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::iterator arg2 ;
@@ -18965,23 +18965,23 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_insert__SWIG_0(PyObject *self, Py_ss
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_insert" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_insert" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t_insert" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T_insert" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t_insert" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T_insert" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_std_complex_Sl_double_Sg_(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_t_insert" "', argument " "3"" of type '" "std::vector< std::complex< double > >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_T_insert" "', argument " "3"" of type '" "std::vector< std::complex< double > >::value_type""'");
   } 
   temp3 = static_cast< std::vector< std::complex< double > >::value_type >(val3);
   arg3 = &temp3;
@@ -18994,7 +18994,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::iterator arg2 ;
@@ -19014,28 +19014,28 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_insert__SWIG_1(PyObject *self, Py_ss
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_insert" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_insert" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t_insert" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T_insert" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t_insert" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T_insert" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_size_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_t_insert" "', argument " "3"" of type '" "std::vector< std::complex< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_T_insert" "', argument " "3"" of type '" "std::vector< std::complex< double > >::size_type""'");
   } 
   arg3 = static_cast< std::vector< std::complex< double > >::size_type >(val3);
   ecode4 = SWIG_AsVal_std_complex_Sl_double_Sg_(swig_obj[3], &val4);
   if (!SWIG_IsOK(ecode4)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode4), "in method '" "vector_complex_t_insert" "', argument " "4"" of type '" "std::vector< std::complex< double > >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode4), "in method '" "vector_complex_T_insert" "', argument " "4"" of type '" "std::vector< std::complex< double > >::value_type""'");
   } 
   temp4 = static_cast< std::vector< std::complex< double > >::value_type >(val4);
   arg4 = &temp4;
@@ -19047,13 +19047,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_insert(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_insert(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_t_insert", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_T_insert", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -19069,7 +19069,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_insert(PyObject *self, PyObject *arg
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_complex_t_insert__SWIG_0(self, argc, argv);
+          return _wrap_vector_complex_T_insert__SWIG_0(self, argc, argv);
         }
       }
     }
@@ -19093,7 +19093,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_insert(PyObject *self, PyObject *arg
             _v = SWIG_CheckState(res);
           }
           if (_v) {
-            return _wrap_vector_complex_t_insert__SWIG_1(self, argc, argv);
+            return _wrap_vector_complex_T_insert__SWIG_1(self, argc, argv);
           }
         }
       }
@@ -19101,7 +19101,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_insert(PyObject *self, PyObject *arg
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_t_insert'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_T_insert'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::complex< double > >::insert(std::vector< std::complex< double > >::iterator,std::vector< std::complex< double > >::value_type const &)\n"
     "    std::vector< std::complex< double > >::insert(std::vector< std::complex< double > >::iterator,std::vector< std::complex< double > >::size_type,std::vector< std::complex< double > >::value_type const &)\n");
@@ -19109,7 +19109,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_reserve(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_reserve(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::size_type arg2 ;
@@ -19120,15 +19120,15 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_reserve(PyObject *self, PyObject *ar
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_complex_t_reserve", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_complex_T_reserve", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_reserve" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_reserve" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t_reserve" "', argument " "2"" of type '" "std::vector< std::complex< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T_reserve" "', argument " "2"" of type '" "std::vector< std::complex< double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::complex< double > >::size_type >(val2);
   (arg1)->reserve(arg2);
@@ -19139,7 +19139,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_capacity(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_capacity(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -19152,7 +19152,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_capacity(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_capacity" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_capacity" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = ((std::vector< std::complex< double > > const *)arg1)->capacity();
@@ -19163,7 +19163,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_delete_vector_complex_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_delete_vector_complex_T(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -19175,7 +19175,7 @@ SWIGINTERN PyObject *_wrap_delete_vector_complex_t(PyObject *self, PyObject *arg
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, SWIG_POINTER_DISOWN |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vector_complex_t" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vector_complex_T" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   {
@@ -19196,18 +19196,18 @@ fail:
 }
 
 
-SWIGINTERN PyObject *vector_complex_t_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vector_complex_T_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   PyObject *obj;
   if (!SWIG_Python_UnpackTuple(args, "swigregister", 1, 1, &obj)) return NULL;
   SWIG_TypeNewClientData(SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, SWIG_NewClientData(obj));
   return SWIG_Py_Void();
 }
 
-SWIGINTERN PyObject *vector_complex_t_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vector_complex_T_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   return SWIG_Python_InitShadowInstance(args);
 }
 
-SWIGINTERN PyObject *_wrap_vector_string_t_iterator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_iterator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   PyObject **arg2 = (PyObject **) 0 ;
@@ -19222,7 +19222,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_iterator(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_iterator" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_iterator" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = (swig::SwigPyIterator *)std_vector_Sl_std_string_Sg__iterator(arg1,arg2);
@@ -19233,7 +19233,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___nonzero__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T___nonzero__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -19246,7 +19246,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t___nonzero__(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___nonzero__" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___nonzero__" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = (bool)std_vector_Sl_std_string_Sg____nonzero__((std::vector< std::string > const *)arg1);
@@ -19257,7 +19257,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___bool__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T___bool__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -19270,7 +19270,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t___bool__(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___bool__" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___bool__" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = (bool)std_vector_Sl_std_string_Sg____bool__((std::vector< std::string > const *)arg1);
@@ -19281,7 +19281,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___len__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T___len__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -19294,7 +19294,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t___len__(PyObject *self, PyObject *arg
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___len__" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___len__" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = std_vector_Sl_std_string_Sg____len__((std::vector< std::string > const *)arg1);
@@ -19305,7 +19305,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___getslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T___getslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::difference_type arg2 ;
@@ -19320,20 +19320,20 @@ SWIGINTERN PyObject *_wrap_vector_string_t___getslice__(PyObject *self, PyObject
   std::vector< std::string,std::allocator< std::string > > *result = 0 ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_string_t___getslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_string_T___getslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___getslice__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___getslice__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_t___getslice__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_T___getslice__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::string >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_string_t___getslice__" "', argument " "3"" of type '" "std::vector< std::string >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_string_T___getslice__" "', argument " "3"" of type '" "std::vector< std::string >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::string >::difference_type >(val3);
   try {
@@ -19350,7 +19350,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::difference_type arg2 ;
@@ -19366,17 +19366,17 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setslice____SWIG_0(PyObject *self,
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___setslice__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___setslice__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_t___setslice__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_T___setslice__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::string >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_string_t___setslice__" "', argument " "3"" of type '" "std::vector< std::string >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_string_T___setslice__" "', argument " "3"" of type '" "std::vector< std::string >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::string >::difference_type >(val3);
   try {
@@ -19393,7 +19393,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::difference_type arg2 ;
@@ -19411,27 +19411,27 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setslice____SWIG_1(PyObject *self,
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___setslice__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___setslice__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_t___setslice__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_T___setslice__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::string >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_string_t___setslice__" "', argument " "3"" of type '" "std::vector< std::string >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_string_T___setslice__" "', argument " "3"" of type '" "std::vector< std::string >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::string >::difference_type >(val3);
   {
     std::vector< std::string,std::allocator< std::string > > *ptr = (std::vector< std::string,std::allocator< std::string > > *)0;
     res4 = swig::asptr(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_string_t___setslice__" "', argument " "4"" of type '" "std::vector< std::string,std::allocator< std::string > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_string_T___setslice__" "', argument " "4"" of type '" "std::vector< std::string,std::allocator< std::string > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_t___setslice__" "', argument " "4"" of type '" "std::vector< std::string,std::allocator< std::string > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_T___setslice__" "', argument " "4"" of type '" "std::vector< std::string,std::allocator< std::string > > const &""'"); 
     }
     arg4 = ptr;
   }
@@ -19451,13 +19451,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___setslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T___setslice__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_t___setslice__", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_T___setslice__", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -19474,7 +19474,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setslice__(PyObject *self, PyObject
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_string_t___setslice____SWIG_0(self, argc, argv);
+          return _wrap_vector_string_T___setslice____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -19497,7 +19497,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setslice__(PyObject *self, PyObject
           int res = swig::asptr(argv[3], (std::vector< std::string,std::allocator< std::string > >**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vector_string_t___setslice____SWIG_1(self, argc, argv);
+            return _wrap_vector_string_T___setslice____SWIG_1(self, argc, argv);
           }
         }
       }
@@ -19505,7 +19505,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setslice__(PyObject *self, PyObject
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_t___setslice__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_T___setslice__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::string >::__setslice__(std::vector< std::string >::difference_type,std::vector< std::string >::difference_type)\n"
     "    std::vector< std::string >::__setslice__(std::vector< std::string >::difference_type,std::vector< std::string >::difference_type,std::vector< std::string,std::allocator< std::string > > const &)\n");
@@ -19513,7 +19513,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___delslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T___delslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::difference_type arg2 ;
@@ -19527,20 +19527,20 @@ SWIGINTERN PyObject *_wrap_vector_string_t___delslice__(PyObject *self, PyObject
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_string_t___delslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_string_T___delslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___delslice__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___delslice__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_t___delslice__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_T___delslice__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::string >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_string_t___delslice__" "', argument " "3"" of type '" "std::vector< std::string >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_string_T___delslice__" "', argument " "3"" of type '" "std::vector< std::string >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::string >::difference_type >(val3);
   try {
@@ -19557,7 +19557,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::difference_type arg2 ;
@@ -19570,12 +19570,12 @@ SWIGINTERN PyObject *_wrap_vector_string_t___delitem____SWIG_0(PyObject *self, P
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___delitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___delitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_t___delitem__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_T___delitem__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::string >::difference_type >(val2);
   try {
@@ -19592,7 +19592,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -19604,12 +19604,12 @@ SWIGINTERN PyObject *_wrap_vector_string_t___getitem____SWIG_0(PyObject *self, P
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___getitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___getitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -19627,7 +19627,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -19640,12 +19640,12 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setitem____SWIG_0(PyObject *self, P
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___setitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___setitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -19653,10 +19653,10 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setitem____SWIG_0(PyObject *self, P
     std::vector< std::string,std::allocator< std::string > > *ptr = (std::vector< std::string,std::allocator< std::string > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_string_t___setitem__" "', argument " "3"" of type '" "std::vector< std::string,std::allocator< std::string > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_string_T___setitem__" "', argument " "3"" of type '" "std::vector< std::string,std::allocator< std::string > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_t___setitem__" "', argument " "3"" of type '" "std::vector< std::string,std::allocator< std::string > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_T___setitem__" "', argument " "3"" of type '" "std::vector< std::string,std::allocator< std::string > > const &""'"); 
     }
     arg3 = ptr;
   }
@@ -19676,7 +19676,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -19687,12 +19687,12 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setitem____SWIG_1(PyObject *self, P
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___setitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___setitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -19710,7 +19710,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -19721,12 +19721,12 @@ SWIGINTERN PyObject *_wrap_vector_string_t___delitem____SWIG_1(PyObject *self, P
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___delitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___delitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -19744,13 +19744,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___delitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T___delitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_t___delitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_T___delitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -19761,7 +19761,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t___delitem__(PyObject *self, PyObject
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_string_t___delitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_string_T___delitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -19775,13 +19775,13 @@ SWIGINTERN PyObject *_wrap_vector_string_t___delitem__(PyObject *self, PyObject
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_string_t___delitem____SWIG_0(self, argc, argv);
+        return _wrap_vector_string_T___delitem____SWIG_0(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_t___delitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_T___delitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::string >::__delitem__(std::vector< std::string >::difference_type)\n"
     "    std::vector< std::string >::__delitem__(SWIGPY_SLICEOBJECT *)\n");
@@ -19789,7 +19789,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::difference_type arg2 ;
@@ -19803,12 +19803,12 @@ SWIGINTERN PyObject *_wrap_vector_string_t___getitem____SWIG_1(PyObject *self, P
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___getitem__" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___getitem__" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_t___getitem__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_T___getitem__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::string >::difference_type >(val2);
   try {
@@ -19824,13 +19824,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___getitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T___getitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_t___getitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_T___getitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -19841,7 +19841,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t___getitem__(PyObject *self, PyObject
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_string_t___getitem____SWIG_0(self, argc, argv);
+        return _wrap_vector_string_T___getitem____SWIG_0(self, argc, argv);
       }
     }
   }
@@ -19855,13 +19855,13 @@ SWIGINTERN PyObject *_wrap_vector_string_t___getitem__(PyObject *self, PyObject
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_string_t___getitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_string_T___getitem____SWIG_1(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_t___getitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_T___getitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::string >::__getitem__(SWIGPY_SLICEOBJECT *)\n"
     "    std::vector< std::string >::__getitem__(std::vector< std::string >::difference_type) const\n");
@@ -19869,7 +19869,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::difference_type arg2 ;
@@ -19884,22 +19884,22 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setitem____SWIG_2(PyObject *self, P
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___setitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___setitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_t___setitem__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_T___setitem__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::string >::difference_type >(val2);
   {
     std::string *ptr = (std::string *)0;
     res3 = SWIG_AsPtr_std_string(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_string_t___setitem__" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_string_T___setitem__" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_t___setitem__" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_T___setitem__" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -19917,13 +19917,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___setitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T___setitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_t___setitem__", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_T___setitem__", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -19934,7 +19934,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setitem__(PyObject *self, PyObject
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_string_t___setitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_string_T___setitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -19950,7 +19950,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setitem__(PyObject *self, PyObject
         int res = swig::asptr(argv[2], (std::vector< std::string,std::allocator< std::string > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vector_string_t___setitem____SWIG_0(self, argc, argv);
+          return _wrap_vector_string_T___setitem____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -19968,14 +19968,14 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setitem__(PyObject *self, PyObject
         int res = SWIG_AsPtr_std_string(argv[2], (std::string**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vector_string_t___setitem____SWIG_2(self, argc, argv);
+          return _wrap_vector_string_T___setitem____SWIG_2(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_t___setitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_T___setitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::string >::__setitem__(SWIGPY_SLICEOBJECT *,std::vector< std::string,std::allocator< std::string > > const &)\n"
     "    std::vector< std::string >::__setitem__(SWIGPY_SLICEOBJECT *)\n"
@@ -19984,7 +19984,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_pop(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_pop(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -19997,7 +19997,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_pop(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_pop" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_pop" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   try {
@@ -20012,7 +20012,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_append(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_append(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::value_type *arg2 = 0 ;
@@ -20022,20 +20022,20 @@ SWIGINTERN PyObject *_wrap_vector_string_t_append(PyObject *self, PyObject *args
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_string_t_append", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_string_T_append", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_append" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_append" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_string_t_append" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_string_T_append" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_t_append" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_T_append" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -20049,7 +20049,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_string_t__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
+SWIGINTERN PyObject *_wrap_new_vector_string_T__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
   PyObject *resultobj = 0;
   std::vector< std::string > *result = 0 ;
   
@@ -20063,7 +20063,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_string_t__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_string_T__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = 0 ;
   int res1 = SWIG_OLDOBJ ;
@@ -20075,10 +20075,10 @@ SWIGINTERN PyObject *_wrap_new_vector_string_t__SWIG_1(PyObject *self, Py_ssize_
     std::vector< std::string,std::allocator< std::string > > *ptr = (std::vector< std::string,std::allocator< std::string > > *)0;
     res1 = swig::asptr(swig_obj[0], &ptr);
     if (!SWIG_IsOK(res1)) {
-      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vector_string_t" "', argument " "1"" of type '" "std::vector< std::string > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vector_string_T" "', argument " "1"" of type '" "std::vector< std::string > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_string_t" "', argument " "1"" of type '" "std::vector< std::string > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_string_T" "', argument " "1"" of type '" "std::vector< std::string > const &""'"); 
     }
     arg1 = ptr;
   }
@@ -20092,7 +20092,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_empty(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_empty(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -20105,7 +20105,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_empty(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_empty" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_empty" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = (bool)((std::vector< std::string > const *)arg1)->empty();
@@ -20116,7 +20116,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_size(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_size(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -20129,7 +20129,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_size(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_size" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_size" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = ((std::vector< std::string > const *)arg1)->size();
@@ -20140,7 +20140,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_swap(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_swap(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string > *arg2 = 0 ;
@@ -20151,18 +20151,18 @@ SWIGINTERN PyObject *_wrap_vector_string_t_swap(PyObject *self, PyObject *args)
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_string_t_swap", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_string_T_swap", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_swap" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_swap" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], &argp2, SWIGTYPE_p_std__vectorT_std__string_t,  0 );
   if (!SWIG_IsOK(res2)) {
-    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_string_t_swap" "', argument " "2"" of type '" "std::vector< std::string > &""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_string_T_swap" "', argument " "2"" of type '" "std::vector< std::string > &""'"); 
   }
   if (!argp2) {
-    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_t_swap" "', argument " "2"" of type '" "std::vector< std::string > &""'"); 
+    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_T_swap" "', argument " "2"" of type '" "std::vector< std::string > &""'"); 
   }
   arg2 = reinterpret_cast< std::vector< std::string > * >(argp2);
   (arg1)->swap(*arg2);
@@ -20173,7 +20173,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_begin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_begin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -20186,7 +20186,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_begin(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_begin" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_begin" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = (arg1)->begin();
@@ -20198,7 +20198,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_end(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_end(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -20211,7 +20211,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_end(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_end" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_end" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = (arg1)->end();
@@ -20223,7 +20223,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_rbegin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_rbegin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -20236,7 +20236,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_rbegin(PyObject *self, PyObject *args
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_rbegin" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_rbegin" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = (arg1)->rbegin();
@@ -20248,7 +20248,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_rend(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_rend(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -20261,7 +20261,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_rend(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_rend" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_rend" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = (arg1)->rend();
@@ -20273,7 +20273,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_clear(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_clear(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -20285,7 +20285,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_clear(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_clear" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_clear" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   (arg1)->clear();
@@ -20296,7 +20296,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_get_allocator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_get_allocator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -20309,7 +20309,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_get_allocator(PyObject *self, PyObjec
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_get_allocator" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_get_allocator" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = ((std::vector< std::string > const *)arg1)->get_allocator();
@@ -20320,7 +20320,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_string_t__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_string_T__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string >::size_type arg1 ;
   size_t val1 ;
@@ -20331,7 +20331,7 @@ SWIGINTERN PyObject *_wrap_new_vector_string_t__SWIG_2(PyObject *self, Py_ssize_
   if ((nobjs < 1) || (nobjs > 1)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_string_t" "', argument " "1"" of type '" "std::vector< std::string >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_string_T" "', argument " "1"" of type '" "std::vector< std::string >::size_type""'");
   } 
   arg1 = static_cast< std::vector< std::string >::size_type >(val1);
   result = (std::vector< std::string > *)new std::vector< std::string >(arg1);
@@ -20342,7 +20342,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_pop_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_pop_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -20354,7 +20354,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_pop_back(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_pop_back" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_pop_back" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   (arg1)->pop_back();
@@ -20365,7 +20365,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::size_type arg2 ;
@@ -20378,12 +20378,12 @@ SWIGINTERN PyObject *_wrap_vector_string_t_resize__SWIG_0(PyObject *self, Py_ssi
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_resize" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_resize" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_t_resize" "', argument " "2"" of type '" "std::vector< std::string >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_T_resize" "', argument " "2"" of type '" "std::vector< std::string >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::string >::size_type >(val2);
   (arg1)->resize(arg2);
@@ -20394,7 +20394,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::iterator arg2 ;
@@ -20408,18 +20408,18 @@ SWIGINTERN PyObject *_wrap_vector_string_t_erase__SWIG_0(PyObject *self, Py_ssiz
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_erase" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_erase" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t_erase" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T_erase" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::string >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::string >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t_erase" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T_erase" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
     }
   }
   result = std_vector_Sl_std_string_Sg__erase__SWIG_0(arg1,SWIG_STD_MOVE(arg2));
@@ -20431,7 +20431,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::iterator arg2 ;
@@ -20448,29 +20448,29 @@ SWIGINTERN PyObject *_wrap_vector_string_t_erase__SWIG_1(PyObject *self, Py_ssiz
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_erase" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_erase" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t_erase" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T_erase" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::string >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::string >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t_erase" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T_erase" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
     }
   }
   res3 = SWIG_ConvertPtr(swig_obj[2], SWIG_as_voidptrptr(&iter3), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res3) || !iter3) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t_erase" "', argument " "3"" of type '" "std::vector< std::string >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T_erase" "', argument " "3"" of type '" "std::vector< std::string >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::string >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::string >::iterator > *>(iter3);
     if (iter_t) {
       arg3 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t_erase" "', argument " "3"" of type '" "std::vector< std::string >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T_erase" "', argument " "3"" of type '" "std::vector< std::string >::iterator""'");
     }
   }
   result = std_vector_Sl_std_string_Sg__erase__SWIG_1(arg1,SWIG_STD_MOVE(arg2),SWIG_STD_MOVE(arg3));
@@ -20482,13 +20482,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_erase(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_erase(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_t_erase", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_T_erase", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -20499,7 +20499,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_erase(PyObject *self, PyObject *args)
       int res = SWIG_ConvertPtr(argv[1], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
       _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< std::string >::iterator > *>(iter) != 0));
       if (_v) {
-        return _wrap_vector_string_t_erase__SWIG_0(self, argc, argv);
+        return _wrap_vector_string_T_erase__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -20516,14 +20516,14 @@ SWIGINTERN PyObject *_wrap_vector_string_t_erase(PyObject *self, PyObject *args)
         int res = SWIG_ConvertPtr(argv[2], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
         _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< std::string >::iterator > *>(iter) != 0));
         if (_v) {
-          return _wrap_vector_string_t_erase__SWIG_1(self, argc, argv);
+          return _wrap_vector_string_T_erase__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_t_erase'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_T_erase'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::string >::erase(std::vector< std::string >::iterator)\n"
     "    std::vector< std::string >::erase(std::vector< std::string >::iterator,std::vector< std::string >::iterator)\n");
@@ -20531,7 +20531,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_string_t__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_string_T__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string >::size_type arg1 ;
   std::vector< std::string >::value_type *arg2 = 0 ;
@@ -20544,17 +20544,17 @@ SWIGINTERN PyObject *_wrap_new_vector_string_t__SWIG_3(PyObject *self, Py_ssize_
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_string_t" "', argument " "1"" of type '" "std::vector< std::string >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_string_T" "', argument " "1"" of type '" "std::vector< std::string >::size_type""'");
   } 
   arg1 = static_cast< std::vector< std::string >::size_type >(val1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "new_vector_string_t" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "new_vector_string_T" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_string_t" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_string_T" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -20568,16 +20568,16 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_string_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_new_vector_string_T(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vector_string_t", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vector_string_T", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 0) {
-    return _wrap_new_vector_string_t__SWIG_0(self, argc, argv);
+    return _wrap_new_vector_string_T__SWIG_0(self, argc, argv);
   }
   if (argc == 1) {
     int _v = 0;
@@ -20586,7 +20586,7 @@ SWIGINTERN PyObject *_wrap_new_vector_string_t(PyObject *self, PyObject *args) {
       _v = SWIG_CheckState(res);
     }
     if (_v) {
-      return _wrap_new_vector_string_t__SWIG_2(self, argc, argv);
+      return _wrap_new_vector_string_T__SWIG_2(self, argc, argv);
     }
   }
   if (argc == 1) {
@@ -20594,7 +20594,7 @@ SWIGINTERN PyObject *_wrap_new_vector_string_t(PyObject *self, PyObject *args) {
     int res = swig::asptr(argv[0], (std::vector< std::string,std::allocator< std::string > >**)(0));
     _v = SWIG_CheckState(res);
     if (_v) {
-      return _wrap_new_vector_string_t__SWIG_1(self, argc, argv);
+      return _wrap_new_vector_string_T__SWIG_1(self, argc, argv);
     }
   }
   if (argc == 2) {
@@ -20607,13 +20607,13 @@ SWIGINTERN PyObject *_wrap_new_vector_string_t(PyObject *self, PyObject *args) {
       int res = SWIG_AsPtr_std_string(argv[1], (std::string**)(0));
       _v = SWIG_CheckState(res);
       if (_v) {
-        return _wrap_new_vector_string_t__SWIG_3(self, argc, argv);
+        return _wrap_new_vector_string_T__SWIG_3(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vector_string_t'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vector_string_T'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::string >::vector()\n"
     "    std::vector< std::string >::vector(std::vector< std::string > const &)\n"
@@ -20623,7 +20623,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_push_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_push_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::value_type *arg2 = 0 ;
@@ -20633,20 +20633,20 @@ SWIGINTERN PyObject *_wrap_vector_string_t_push_back(PyObject *self, PyObject *a
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_string_t_push_back", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_string_T_push_back", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_push_back" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_push_back" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_string_t_push_back" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_string_T_push_back" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_t_push_back" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_T_push_back" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -20660,7 +20660,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_front(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_front(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -20673,7 +20673,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_front(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_front" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_front" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = (std::vector< std::string >::value_type *) &((std::vector< std::string > const *)arg1)->front();
@@ -20685,7 +20685,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -20698,7 +20698,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_back(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_back" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_back" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = (std::vector< std::string >::value_type *) &((std::vector< std::string > const *)arg1)->back();
@@ -20710,7 +20710,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_assign(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_assign(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::size_type arg2 ;
@@ -20723,25 +20723,25 @@ SWIGINTERN PyObject *_wrap_vector_string_t_assign(PyObject *self, PyObject *args
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_string_t_assign", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_string_T_assign", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_assign" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_assign" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_t_assign" "', argument " "2"" of type '" "std::vector< std::string >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_T_assign" "', argument " "2"" of type '" "std::vector< std::string >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::string >::size_type >(val2);
   {
     std::string *ptr = (std::string *)0;
     res3 = SWIG_AsPtr_std_string(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_string_t_assign" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_string_T_assign" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_t_assign" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_T_assign" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -20755,7 +20755,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::size_type arg2 ;
@@ -20770,22 +20770,22 @@ SWIGINTERN PyObject *_wrap_vector_string_t_resize__SWIG_1(PyObject *self, Py_ssi
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_resize" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_resize" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_t_resize" "', argument " "2"" of type '" "std::vector< std::string >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_T_resize" "', argument " "2"" of type '" "std::vector< std::string >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::string >::size_type >(val2);
   {
     std::string *ptr = (std::string *)0;
     res3 = SWIG_AsPtr_std_string(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_string_t_resize" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_string_T_resize" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_t_resize" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_T_resize" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -20799,13 +20799,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_resize(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_resize(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_t_resize", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_T_resize", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -20817,7 +20817,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_resize(PyObject *self, PyObject *args
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_string_t_resize__SWIG_0(self, argc, argv);
+        return _wrap_vector_string_T_resize__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -20834,14 +20834,14 @@ SWIGINTERN PyObject *_wrap_vector_string_t_resize(PyObject *self, PyObject *args
         int res = SWIG_AsPtr_std_string(argv[2], (std::string**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vector_string_t_resize__SWIG_1(self, argc, argv);
+          return _wrap_vector_string_T_resize__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_t_resize'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_T_resize'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::string >::resize(std::vector< std::string >::size_type)\n"
     "    std::vector< std::string >::resize(std::vector< std::string >::size_type,std::vector< std::string >::value_type const &)\n");
@@ -20849,7 +20849,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::iterator arg2 ;
@@ -20865,28 +20865,28 @@ SWIGINTERN PyObject *_wrap_vector_string_t_insert__SWIG_0(PyObject *self, Py_ssi
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_insert" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_insert" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t_insert" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T_insert" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::string >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::string >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t_insert" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T_insert" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
     }
   }
   {
     std::string *ptr = (std::string *)0;
     res3 = SWIG_AsPtr_std_string(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_string_t_insert" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_string_T_insert" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_t_insert" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_T_insert" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -20901,7 +20901,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::iterator arg2 ;
@@ -20919,33 +20919,33 @@ SWIGINTERN PyObject *_wrap_vector_string_t_insert__SWIG_1(PyObject *self, Py_ssi
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_insert" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_insert" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t_insert" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T_insert" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::string >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::string >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t_insert" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T_insert" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_size_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_string_t_insert" "', argument " "3"" of type '" "std::vector< std::string >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_string_T_insert" "', argument " "3"" of type '" "std::vector< std::string >::size_type""'");
   } 
   arg3 = static_cast< std::vector< std::string >::size_type >(val3);
   {
     std::string *ptr = (std::string *)0;
     res4 = SWIG_AsPtr_std_string(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_string_t_insert" "', argument " "4"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_string_T_insert" "', argument " "4"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_t_insert" "', argument " "4"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_T_insert" "', argument " "4"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     arg4 = ptr;
   }
@@ -20959,13 +20959,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_insert(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_insert(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_t_insert", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_T_insert", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -20979,7 +20979,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_insert(PyObject *self, PyObject *args
         int res = SWIG_AsPtr_std_string(argv[2], (std::string**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vector_string_t_insert__SWIG_0(self, argc, argv);
+          return _wrap_vector_string_T_insert__SWIG_0(self, argc, argv);
         }
       }
     }
@@ -21001,7 +21001,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_insert(PyObject *self, PyObject *args
           int res = SWIG_AsPtr_std_string(argv[3], (std::string**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vector_string_t_insert__SWIG_1(self, argc, argv);
+            return _wrap_vector_string_T_insert__SWIG_1(self, argc, argv);
           }
         }
       }
@@ -21009,7 +21009,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_insert(PyObject *self, PyObject *args
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_t_insert'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_T_insert'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::string >::insert(std::vector< std::string >::iterator,std::vector< std::string >::value_type const &)\n"
     "    std::vector< std::string >::insert(std::vector< std::string >::iterator,std::vector< std::string >::size_type,std::vector< std::string >::value_type const &)\n");
@@ -21017,7 +21017,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_reserve(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_reserve(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::size_type arg2 ;
@@ -21028,15 +21028,15 @@ SWIGINTERN PyObject *_wrap_vector_string_t_reserve(PyObject *self, PyObject *arg
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_string_t_reserve", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_string_T_reserve", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_reserve" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_reserve" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_t_reserve" "', argument " "2"" of type '" "std::vector< std::string >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_T_reserve" "', argument " "2"" of type '" "std::vector< std::string >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::string >::size_type >(val2);
   (arg1)->reserve(arg2);
@@ -21047,7 +21047,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_capacity(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_capacity(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -21060,7 +21060,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_capacity(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_capacity" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_capacity" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = ((std::vector< std::string > const *)arg1)->capacity();
@@ -21071,7 +21071,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_delete_vector_string_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_delete_vector_string_T(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -21083,7 +21083,7 @@ SWIGINTERN PyObject *_wrap_delete_vector_string_t(PyObject *self, PyObject *args
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, SWIG_POINTER_DISOWN |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vector_string_t" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vector_string_T" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   {
@@ -21104,18 +21104,18 @@ fail:
 }
 
 
-SWIGINTERN PyObject *vector_string_t_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vector_string_T_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   PyObject *obj;
   if (!SWIG_Python_UnpackTuple(args, "swigregister", 1, 1, &obj)) return NULL;
   SWIG_TypeNewClientData(SWIGTYPE_p_std__vectorT_std__string_t, SWIG_NewClientData(obj));
   return SWIG_Py_Void();
 }
 
-SWIGINTERN PyObject *vector_string_t_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vector_string_T_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   return SWIG_Python_InitShadowInstance(args);
 }
 
-SWIGINTERN PyObject *_wrap_new_map_string_double_t__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_map_string_double_T__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::less< std::string > *arg1 = 0 ;
   void *argp1 = 0 ;
@@ -21126,10 +21126,10 @@ SWIGINTERN PyObject *_wrap_new_map_string_double_t__SWIG_0(PyObject *self, Py_ss
   if ((nobjs < 1) || (nobjs > 1)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1, SWIGTYPE_p_std__lessT_std__string_t,  0  | 0);
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_map_string_double_t" "', argument " "1"" of type '" "std::less< std::string > const &""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_map_string_double_T" "', argument " "1"" of type '" "std::less< std::string > const &""'"); 
   }
   if (!argp1) {
-    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_map_string_double_t" "', argument " "1"" of type '" "std::less< std::string > const &""'"); 
+    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_map_string_double_T" "', argument " "1"" of type '" "std::less< std::string > const &""'"); 
   }
   arg1 = reinterpret_cast< std::less< std::string > * >(argp1);
   result = (std::map< std::string,double > *)new std::map< std::string,double >((std::less< std::string > const &)*arg1);
@@ -21140,7 +21140,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_iterator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_iterator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   PyObject **arg2 = (PyObject **) 0 ;
@@ -21155,7 +21155,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_iterator(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_iterator" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_iterator" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (swig::SwigPyIterator *)std_map_Sl_std_string_Sc_double_Sg__iterator(arg1,arg2);
@@ -21166,7 +21166,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t___nonzero__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T___nonzero__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -21179,7 +21179,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t___nonzero__(PyObject *self, PyObj
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t___nonzero__" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T___nonzero__" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (bool)std_map_Sl_std_string_Sc_double_Sg____nonzero__((std::map< std::string,double > const *)arg1);
@@ -21190,7 +21190,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t___bool__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T___bool__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -21203,7 +21203,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t___bool__(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t___bool__" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T___bool__" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (bool)std_map_Sl_std_string_Sc_double_Sg____bool__((std::map< std::string,double > const *)arg1);
@@ -21214,7 +21214,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t___len__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T___len__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -21227,7 +21227,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t___len__(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t___len__" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T___len__" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = std_map_Sl_std_string_Sc_double_Sg____len__((std::map< std::string,double > const *)arg1);
@@ -21238,7 +21238,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t___getitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T___getitem__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::key_type *arg2 = 0 ;
@@ -21249,20 +21249,20 @@ SWIGINTERN PyObject *_wrap_map_string_double_t___getitem__(PyObject *self, PyObj
   std::map< std::string,double >::mapped_type *result = 0 ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "map_string_double_t___getitem__", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "map_string_double_T___getitem__", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t___getitem__" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T___getitem__" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t___getitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T___getitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t___getitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T___getitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -21280,7 +21280,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t___delitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T___delitem__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::key_type *arg2 = 0 ;
@@ -21290,20 +21290,20 @@ SWIGINTERN PyObject *_wrap_map_string_double_t___delitem__(PyObject *self, PyObj
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "map_string_double_t___delitem__", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "map_string_double_T___delitem__", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t___delitem__" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T___delitem__" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t___delitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T___delitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t___delitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T___delitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -21321,7 +21321,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_has_key(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_has_key(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::key_type *arg2 = 0 ;
@@ -21332,20 +21332,20 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_has_key(PyObject *self, PyObject
   bool result;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "map_string_double_t_has_key", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "map_string_double_T_has_key", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_has_key" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_has_key" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t_has_key" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T_has_key" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t_has_key" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T_has_key" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -21359,7 +21359,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_keys(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_keys(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -21372,7 +21372,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_keys(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_keys" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_keys" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (PyObject *)std_map_Sl_std_string_Sc_double_Sg__keys(arg1);
@@ -21383,7 +21383,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_values(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_values(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -21396,7 +21396,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_values(PyObject *self, PyObject *
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_values" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_values" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (PyObject *)std_map_Sl_std_string_Sc_double_Sg__values(arg1);
@@ -21407,7 +21407,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_items(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_items(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -21420,7 +21420,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_items(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_items" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_items" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (PyObject *)std_map_Sl_std_string_Sc_double_Sg__items(arg1);
@@ -21431,7 +21431,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t___contains__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T___contains__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::key_type *arg2 = 0 ;
@@ -21442,20 +21442,20 @@ SWIGINTERN PyObject *_wrap_map_string_double_t___contains__(PyObject *self, PyOb
   bool result;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "map_string_double_t___contains__", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "map_string_double_T___contains__", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t___contains__" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T___contains__" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t___contains__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T___contains__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t___contains__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T___contains__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -21469,7 +21469,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_key_iterator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_key_iterator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   PyObject **arg2 = (PyObject **) 0 ;
@@ -21484,7 +21484,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_key_iterator(PyObject *self, PyOb
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_key_iterator" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_key_iterator" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (swig::SwigPyIterator *)std_map_Sl_std_string_Sc_double_Sg__key_iterator(arg1,arg2);
@@ -21495,7 +21495,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_value_iterator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_value_iterator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   PyObject **arg2 = (PyObject **) 0 ;
@@ -21510,7 +21510,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_value_iterator(PyObject *self, Py
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_value_iterator" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_value_iterator" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (swig::SwigPyIterator *)std_map_Sl_std_string_Sc_double_Sg__value_iterator(arg1,arg2);
@@ -21521,7 +21521,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_map_string_double_T___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::key_type *arg2 = 0 ;
@@ -21533,17 +21533,17 @@ SWIGINTERN PyObject *_wrap_map_string_double_t___setitem____SWIG_0(PyObject *sel
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t___setitem__" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T___setitem__" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t___setitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T___setitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t___setitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T___setitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -21557,7 +21557,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_map_string_double_T___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::key_type *arg2 = 0 ;
@@ -21573,23 +21573,23 @@ SWIGINTERN PyObject *_wrap_map_string_double_t___setitem____SWIG_1(PyObject *sel
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t___setitem__" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T___setitem__" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t___setitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T___setitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t___setitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T___setitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     arg2 = ptr;
   }
   ecode3 = SWIG_AsVal_double(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "map_string_double_t___setitem__" "', argument " "3"" of type '" "std::map< std::string,double >::mapped_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "map_string_double_T___setitem__" "', argument " "3"" of type '" "std::map< std::string,double >::mapped_type""'");
   } 
   temp3 = static_cast< std::map< std::string,double >::mapped_type >(val3);
   arg3 = &temp3;
@@ -21607,13 +21607,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t___setitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T___setitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "map_string_double_t___setitem__", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "map_string_double_T___setitem__", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -21623,7 +21623,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t___setitem__(PyObject *self, PyObj
       int res = SWIG_AsPtr_std_string(argv[1], (std::string**)(0));
       _v = SWIG_CheckState(res);
       if (_v) {
-        return _wrap_map_string_double_t___setitem____SWIG_0(self, argc, argv);
+        return _wrap_map_string_double_T___setitem____SWIG_0(self, argc, argv);
       }
     }
   }
@@ -21640,14 +21640,14 @@ SWIGINTERN PyObject *_wrap_map_string_double_t___setitem__(PyObject *self, PyObj
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_map_string_double_t___setitem____SWIG_1(self, argc, argv);
+          return _wrap_map_string_double_T___setitem____SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'map_string_double_t___setitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'map_string_double_T___setitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::map< std::string,double >::__setitem__(std::map< std::string,double >::key_type const &)\n"
     "    std::map< std::string,double >::__setitem__(std::map< std::string,double >::key_type const &,std::map< std::string,double >::mapped_type const &)\n");
@@ -21655,7 +21655,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_asdict(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_asdict(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -21668,7 +21668,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_asdict(PyObject *self, PyObject *
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_asdict" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_asdict" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (PyObject *)std_map_Sl_std_string_Sc_double_Sg__asdict(arg1);
@@ -21679,7 +21679,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_map_string_double_t__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
+SWIGINTERN PyObject *_wrap_new_map_string_double_T__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *result = 0 ;
   
@@ -21693,7 +21693,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_map_string_double_t__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_map_string_double_T__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = 0 ;
   int res1 = SWIG_OLDOBJ ;
@@ -21705,10 +21705,10 @@ SWIGINTERN PyObject *_wrap_new_map_string_double_t__SWIG_2(PyObject *self, Py_ss
     std::map< std::string,double,std::less< std::string >,std::allocator< std::pair< std::string const,double > > > *ptr = (std::map< std::string,double,std::less< std::string >,std::allocator< std::pair< std::string const,double > > > *)0;
     res1 = swig::asptr(swig_obj[0], &ptr);
     if (!SWIG_IsOK(res1)) {
-      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_map_string_double_t" "', argument " "1"" of type '" "std::map< std::string,double > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_map_string_double_T" "', argument " "1"" of type '" "std::map< std::string,double > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_map_string_double_t" "', argument " "1"" of type '" "std::map< std::string,double > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_map_string_double_T" "', argument " "1"" of type '" "std::map< std::string,double > const &""'"); 
     }
     arg1 = ptr;
   }
@@ -21722,23 +21722,23 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_map_string_double_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_new_map_string_double_T(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[2] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "new_map_string_double_t", 0, 1, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "new_map_string_double_T", 0, 1, argv))) SWIG_fail;
   --argc;
   if (argc == 0) {
-    return _wrap_new_map_string_double_t__SWIG_1(self, argc, argv);
+    return _wrap_new_map_string_double_T__SWIG_1(self, argc, argv);
   }
   if (argc == 1) {
     int _v = 0;
     int res = SWIG_ConvertPtr(argv[0], 0, SWIGTYPE_p_std__lessT_std__string_t, SWIG_POINTER_NO_NULL | 0);
     _v = SWIG_CheckState(res);
     if (_v) {
-      return _wrap_new_map_string_double_t__SWIG_0(self, argc, argv);
+      return _wrap_new_map_string_double_T__SWIG_0(self, argc, argv);
     }
   }
   if (argc == 1) {
@@ -21746,12 +21746,12 @@ SWIGINTERN PyObject *_wrap_new_map_string_double_t(PyObject *self, PyObject *arg
     int res = swig::asptr(argv[0], (std::map< std::string,double,std::less< std::string >,std::allocator< std::pair< std::string const,double > > >**)(0));
     _v = SWIG_CheckState(res);
     if (_v) {
-      return _wrap_new_map_string_double_t__SWIG_2(self, argc, argv);
+      return _wrap_new_map_string_double_T__SWIG_2(self, argc, argv);
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_map_string_double_t'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_map_string_double_T'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::map< std::string,double >::map(std::less< std::string > const &)\n"
     "    std::map< std::string,double >::map()\n"
@@ -21760,7 +21760,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_empty(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_empty(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -21773,7 +21773,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_empty(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_empty" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_empty" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (bool)((std::map< std::string,double > const *)arg1)->empty();
@@ -21784,7 +21784,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_size(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_size(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -21797,7 +21797,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_size(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_size" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_size" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = ((std::map< std::string,double > const *)arg1)->size();
@@ -21808,7 +21808,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_swap(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_swap(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double > *arg2 = 0 ;
@@ -21819,18 +21819,18 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_swap(PyObject *self, PyObject *ar
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "map_string_double_t_swap", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "map_string_double_T_swap", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_swap" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_swap" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], &argp2, SWIGTYPE_p_std__mapT_std__string_double_t,  0 );
   if (!SWIG_IsOK(res2)) {
-    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t_swap" "', argument " "2"" of type '" "std::map< std::string,double > &""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T_swap" "', argument " "2"" of type '" "std::map< std::string,double > &""'"); 
   }
   if (!argp2) {
-    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t_swap" "', argument " "2"" of type '" "std::map< std::string,double > &""'"); 
+    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T_swap" "', argument " "2"" of type '" "std::map< std::string,double > &""'"); 
   }
   arg2 = reinterpret_cast< std::map< std::string,double > * >(argp2);
   (arg1)->swap(*arg2);
@@ -21841,7 +21841,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_begin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_begin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -21854,7 +21854,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_begin(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_begin" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_begin" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (arg1)->begin();
@@ -21866,7 +21866,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_end(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_end(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -21879,7 +21879,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_end(PyObject *self, PyObject *arg
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_end" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_end" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (arg1)->end();
@@ -21891,7 +21891,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_rbegin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_rbegin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -21904,7 +21904,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_rbegin(PyObject *self, PyObject *
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_rbegin" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_rbegin" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (arg1)->rbegin();
@@ -21916,7 +21916,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_rend(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_rend(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -21929,7 +21929,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_rend(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_rend" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_rend" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (arg1)->rend();
@@ -21941,7 +21941,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_clear(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_clear(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -21953,7 +21953,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_clear(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_clear" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_clear" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   (arg1)->clear();
@@ -21964,7 +21964,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_get_allocator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_get_allocator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -21977,7 +21977,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_get_allocator(PyObject *self, PyO
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_get_allocator" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_get_allocator" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = ((std::map< std::string,double > const *)arg1)->get_allocator();
@@ -21988,7 +21988,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::key_type *arg2 = 0 ;
@@ -22001,17 +22001,17 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_erase__SWIG_0(PyObject *self, Py_
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_erase" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_erase" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t_erase" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T_erase" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t_erase" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T_erase" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -22025,7 +22025,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_count(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_count(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::key_type *arg2 = 0 ;
@@ -22036,20 +22036,20 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_count(PyObject *self, PyObject *a
   std::map< std::string,double >::size_type result;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "map_string_double_t_count", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "map_string_double_T_count", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_count" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_count" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t_count" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T_count" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t_count" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T_count" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -22063,7 +22063,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::iterator arg2 ;
@@ -22076,18 +22076,18 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_erase__SWIG_1(PyObject *self, Py_
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_erase" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_erase" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_t_erase" "', argument " "2"" of type '" "std::map< std::string,double >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_T_erase" "', argument " "2"" of type '" "std::map< std::string,double >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::map< std::string,double >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::map< std::string,double >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_t_erase" "', argument " "2"" of type '" "std::map< std::string,double >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_T_erase" "', argument " "2"" of type '" "std::map< std::string,double >::iterator""'");
     }
   }
   std_map_Sl_std_string_Sc_double_Sg__erase__SWIG_1(arg1,SWIG_STD_MOVE(arg2));
@@ -22098,7 +22098,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_erase__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_erase__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::iterator arg2 ;
@@ -22114,29 +22114,29 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_erase__SWIG_2(PyObject *self, Py_
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_erase" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_erase" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_t_erase" "', argument " "2"" of type '" "std::map< std::string,double >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_T_erase" "', argument " "2"" of type '" "std::map< std::string,double >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::map< std::string,double >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::map< std::string,double >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_t_erase" "', argument " "2"" of type '" "std::map< std::string,double >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_T_erase" "', argument " "2"" of type '" "std::map< std::string,double >::iterator""'");
     }
   }
   res3 = SWIG_ConvertPtr(swig_obj[2], SWIG_as_voidptrptr(&iter3), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res3) || !iter3) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_t_erase" "', argument " "3"" of type '" "std::map< std::string,double >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_T_erase" "', argument " "3"" of type '" "std::map< std::string,double >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::map< std::string,double >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::map< std::string,double >::iterator > *>(iter3);
     if (iter_t) {
       arg3 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_t_erase" "', argument " "3"" of type '" "std::map< std::string,double >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_T_erase" "', argument " "3"" of type '" "std::map< std::string,double >::iterator""'");
     }
   }
   std_map_Sl_std_string_Sc_double_Sg__erase__SWIG_2(arg1,SWIG_STD_MOVE(arg2),SWIG_STD_MOVE(arg3));
@@ -22147,13 +22147,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_erase(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_erase(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "map_string_double_t_erase", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "map_string_double_T_erase", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -22164,7 +22164,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_erase(PyObject *self, PyObject *a
       int res = SWIG_ConvertPtr(argv[1], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
       _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::map< std::string,double >::iterator > *>(iter) != 0));
       if (_v) {
-        return _wrap_map_string_double_t_erase__SWIG_1(self, argc, argv);
+        return _wrap_map_string_double_T_erase__SWIG_1(self, argc, argv);
       }
     }
   }
@@ -22176,7 +22176,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_erase(PyObject *self, PyObject *a
       int res = SWIG_AsPtr_std_string(argv[1], (std::string**)(0));
       _v = SWIG_CheckState(res);
       if (_v) {
-        return _wrap_map_string_double_t_erase__SWIG_0(self, argc, argv);
+        return _wrap_map_string_double_T_erase__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -22193,14 +22193,14 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_erase(PyObject *self, PyObject *a
         int res = SWIG_ConvertPtr(argv[2], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
         _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::map< std::string,double >::iterator > *>(iter) != 0));
         if (_v) {
-          return _wrap_map_string_double_t_erase__SWIG_2(self, argc, argv);
+          return _wrap_map_string_double_T_erase__SWIG_2(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'map_string_double_t_erase'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'map_string_double_T_erase'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::map< std::string,double >::erase(std::map< std::string,double >::key_type const &)\n"
     "    std::map< std::string,double >::erase(std::map< std::string,double >::iterator)\n"
@@ -22209,7 +22209,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_find(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_find(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::key_type *arg2 = 0 ;
@@ -22220,20 +22220,20 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_find(PyObject *self, PyObject *ar
   std::map< std::string,double >::iterator result;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "map_string_double_t_find", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "map_string_double_T_find", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_find" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_find" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t_find" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T_find" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t_find" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T_find" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -22248,7 +22248,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_lower_bound(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_lower_bound(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::key_type *arg2 = 0 ;
@@ -22259,20 +22259,20 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_lower_bound(PyObject *self, PyObj
   std::map< std::string,double >::iterator result;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "map_string_double_t_lower_bound", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "map_string_double_T_lower_bound", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_lower_bound" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_lower_bound" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t_lower_bound" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T_lower_bound" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t_lower_bound" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T_lower_bound" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -22287,7 +22287,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_upper_bound(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_upper_bound(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::key_type *arg2 = 0 ;
@@ -22298,20 +22298,20 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_upper_bound(PyObject *self, PyObj
   std::map< std::string,double >::iterator result;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "map_string_double_t_upper_bound", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "map_string_double_T_upper_bound", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_upper_bound" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_upper_bound" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t_upper_bound" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T_upper_bound" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t_upper_bound" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T_upper_bound" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -22326,7 +22326,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_delete_map_string_double_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_delete_map_string_double_T(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -22338,7 +22338,7 @@ SWIGINTERN PyObject *_wrap_delete_map_string_double_t(PyObject *self, PyObject *
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, SWIG_POINTER_DISOWN |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_map_string_double_t" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_map_string_double_T" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
@@ -22359,18 +22359,18 @@ fail:
 }
 
 
-SWIGINTERN PyObject *map_string_double_t_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *map_string_double_T_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   PyObject *obj;
   if (!SWIG_Python_UnpackTuple(args, "swigregister", 1, 1, &obj)) return NULL;
   SWIG_TypeNewClientData(SWIGTYPE_p_std__mapT_std__string_double_t, SWIG_NewClientData(obj));
   return SWIG_Py_Void();
 }
 
-SWIGINTERN PyObject *map_string_double_t_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *map_string_double_T_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   return SWIG_Python_InitShadowInstance(args);
 }
 
-SWIGINTERN PyObject *_wrap_new_pvacuum_double_t__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
+SWIGINTERN PyObject *_wrap_new_pvacuum_double_T__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
   PyObject *resultobj = 0;
   std::pair< double,double > *result = 0 ;
   
@@ -22384,7 +22384,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_pvacuum_double_t__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_pvacuum_double_T__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   double arg1 ;
   double arg2 ;
@@ -22398,12 +22398,12 @@ SWIGINTERN PyObject *_wrap_new_pvacuum_double_t__SWIG_1(PyObject *self, Py_ssize
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   ecode1 = SWIG_AsVal_double(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_pvacuum_double_t" "', argument " "1"" of type '" "double""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_pvacuum_double_T" "', argument " "1"" of type '" "double""'");
   } 
   arg1 = static_cast< double >(val1);
   ecode2 = SWIG_AsVal_double(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "new_pvacuum_double_t" "', argument " "2"" of type '" "double""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "new_pvacuum_double_T" "', argument " "2"" of type '" "double""'");
   } 
   arg2 = static_cast< double >(val2);
   result = (std::pair< double,double > *)new std::pair< double,double >(arg1,arg2);
@@ -22414,7 +22414,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_pvacuum_double_t__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_pvacuum_double_T__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::pair< double,double > *arg1 = 0 ;
   int res1 = SWIG_OLDOBJ ;
@@ -22426,10 +22426,10 @@ SWIGINTERN PyObject *_wrap_new_pvacuum_double_t__SWIG_2(PyObject *self, Py_ssize
     std::pair< double,double > *ptr = (std::pair< double,double > *)0;
     res1 = swig::asptr(swig_obj[0], &ptr);
     if (!SWIG_IsOK(res1)) {
-      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_pvacuum_double_t" "', argument " "1"" of type '" "std::pair< double,double > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_pvacuum_double_T" "', argument " "1"" of type '" "std::pair< double,double > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_pvacuum_double_t" "', argument " "1"" of type '" "std::pair< double,double > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_pvacuum_double_T" "', argument " "1"" of type '" "std::pair< double,double > const &""'"); 
     }
     arg1 = ptr;
   }
@@ -22443,23 +22443,23 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_pvacuum_double_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_new_pvacuum_double_T(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "new_pvacuum_double_t", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "new_pvacuum_double_T", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 0) {
-    return _wrap_new_pvacuum_double_t__SWIG_0(self, argc, argv);
+    return _wrap_new_pvacuum_double_T__SWIG_0(self, argc, argv);
   }
   if (argc == 1) {
     int _v = 0;
     int res = swig::asptr(argv[0], (std::pair< double,double >**)(0));
     _v = SWIG_CheckState(res);
     if (_v) {
-      return _wrap_new_pvacuum_double_t__SWIG_2(self, argc, argv);
+      return _wrap_new_pvacuum_double_T__SWIG_2(self, argc, argv);
     }
   }
   if (argc == 2) {
@@ -22474,13 +22474,13 @@ SWIGINTERN PyObject *_wrap_new_pvacuum_double_t(PyObject *self, PyObject *args)
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_new_pvacuum_double_t__SWIG_1(self, argc, argv);
+        return _wrap_new_pvacuum_double_T__SWIG_1(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_pvacuum_double_t'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_pvacuum_double_T'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::pair< double,double >::pair()\n"
     "    std::pair< double,double >::pair(double,double)\n"
@@ -22489,7 +22489,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_pvacuum_double_t_first_set(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_pvacuum_double_T_first_set(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::pair< double,double > *arg1 = (std::pair< double,double > *) 0 ;
   double arg2 ;
@@ -22500,15 +22500,15 @@ SWIGINTERN PyObject *_wrap_pvacuum_double_t_first_set(PyObject *self, PyObject *
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "pvacuum_double_t_first_set", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "pvacuum_double_T_first_set", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__pairT_double_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "pvacuum_double_t_first_set" "', argument " "1"" of type '" "std::pair< double,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "pvacuum_double_T_first_set" "', argument " "1"" of type '" "std::pair< double,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::pair< double,double > * >(argp1);
   ecode2 = SWIG_AsVal_double(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "pvacuum_double_t_first_set" "', argument " "2"" of type '" "double""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "pvacuum_double_T_first_set" "', argument " "2"" of type '" "double""'");
   } 
   arg2 = static_cast< double >(val2);
   if (arg1) (arg1)->first = arg2;
@@ -22519,7 +22519,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_pvacuum_double_t_first_get(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_pvacuum_double_T_first_get(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::pair< double,double > *arg1 = (std::pair< double,double > *) 0 ;
   void *argp1 = 0 ;
@@ -22532,7 +22532,7 @@ SWIGINTERN PyObject *_wrap_pvacuum_double_t_first_get(PyObject *self, PyObject *
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__pairT_double_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "pvacuum_double_t_first_get" "', argument " "1"" of type '" "std::pair< double,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "pvacuum_double_T_first_get" "', argument " "1"" of type '" "std::pair< double,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::pair< double,double > * >(argp1);
   result = (double) ((arg1)->first);
@@ -22543,7 +22543,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_pvacuum_double_t_second_set(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_pvacuum_double_T_second_set(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::pair< double,double > *arg1 = (std::pair< double,double > *) 0 ;
   double arg2 ;
@@ -22554,15 +22554,15 @@ SWIGINTERN PyObject *_wrap_pvacuum_double_t_second_set(PyObject *self, PyObject
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "pvacuum_double_t_second_set", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "pvacuum_double_T_second_set", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__pairT_double_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "pvacuum_double_t_second_set" "', argument " "1"" of type '" "std::pair< double,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "pvacuum_double_T_second_set" "', argument " "1"" of type '" "std::pair< double,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::pair< double,double > * >(argp1);
   ecode2 = SWIG_AsVal_double(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "pvacuum_double_t_second_set" "', argument " "2"" of type '" "double""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "pvacuum_double_T_second_set" "', argument " "2"" of type '" "double""'");
   } 
   arg2 = static_cast< double >(val2);
   if (arg1) (arg1)->second = arg2;
@@ -22573,7 +22573,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_pvacuum_double_t_second_get(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_pvacuum_double_T_second_get(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::pair< double,double > *arg1 = (std::pair< double,double > *) 0 ;
   void *argp1 = 0 ;
@@ -22586,7 +22586,7 @@ SWIGINTERN PyObject *_wrap_pvacuum_double_t_second_get(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__pairT_double_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "pvacuum_double_t_second_get" "', argument " "1"" of type '" "std::pair< double,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "pvacuum_double_T_second_get" "', argument " "1"" of type '" "std::pair< double,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::pair< double,double > * >(argp1);
   result = (double) ((arg1)->second);
@@ -22597,7 +22597,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_delete_pvacuum_double_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_delete_pvacuum_double_T(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::pair< double,double > *arg1 = (std::pair< double,double > *) 0 ;
   void *argp1 = 0 ;
@@ -22609,7 +22609,7 @@ SWIGINTERN PyObject *_wrap_delete_pvacuum_double_t(PyObject *self, PyObject *arg
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__pairT_double_double_t, SWIG_POINTER_DISOWN |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_pvacuum_double_t" "', argument " "1"" of type '" "std::pair< double,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_pvacuum_double_T" "', argument " "1"" of type '" "std::pair< double,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::pair< double,double > * >(argp1);
   {
@@ -22630,18 +22630,18 @@ fail:
 }
 
 
-SWIGINTERN PyObject *pvacuum_double_t_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *pvacuum_double_T_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   PyObject *obj;
   if (!SWIG_Python_UnpackTuple(args, "swigregister", 1, 1, &obj)) return NULL;
   SWIG_TypeNewClientData(SWIGTYPE_p_std__pairT_double_double_t, SWIG_NewClientData(obj));
   return SWIG_Py_Void();
 }
 
-SWIGINTERN PyObject *pvacuum_double_t_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *pvacuum_double_T_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   return SWIG_Python_InitShadowInstance(args);
 }
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_iterator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_iterator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   PyObject **arg2 = (PyObject **) 0 ;
@@ -22656,7 +22656,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_iterator(PyObject *self, PyOb
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_iterator" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_iterator" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = (swig::SwigPyIterator *)std_vector_Sl_std_pair_Sl_double_Sc_double_Sg__Sg__iterator(arg1,arg2);
@@ -22667,7 +22667,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___nonzero__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___nonzero__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -22680,7 +22680,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___nonzero__(PyObject *self, P
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___nonzero__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___nonzero__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = (bool)std_vector_Sl_std_pair_Sl_double_Sc_double_Sg__Sg____nonzero__((std::vector< std::pair< double,double > > const *)arg1);
@@ -22691,7 +22691,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___bool__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___bool__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -22704,7 +22704,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___bool__(PyObject *self, PyOb
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___bool__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___bool__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = (bool)std_vector_Sl_std_pair_Sl_double_Sc_double_Sg__Sg____bool__((std::vector< std::pair< double,double > > const *)arg1);
@@ -22715,7 +22715,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___len__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___len__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -22728,7 +22728,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___len__(PyObject *self, PyObj
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___len__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___len__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = std_vector_Sl_std_pair_Sl_double_Sc_double_Sg__Sg____len__((std::vector< std::pair< double,double > > const *)arg1);
@@ -22739,7 +22739,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___getslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___getslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::difference_type arg2 ;
@@ -22754,20 +22754,20 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___getslice__(PyObject *self,
   std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > *result = 0 ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t___getslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T___getslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___getslice__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___getslice__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_t___getslice__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_T___getslice__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::pair< double,double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_pvacuum_double_t___getslice__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_pvacuum_double_T___getslice__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::pair< double,double > >::difference_type >(val3);
   try {
@@ -22784,7 +22784,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::difference_type arg2 ;
@@ -22800,17 +22800,17 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setslice____SWIG_0(PyObject
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___setslice__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___setslice__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_t___setslice__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_T___setslice__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::pair< double,double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_pvacuum_double_t___setslice__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_pvacuum_double_T___setslice__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::pair< double,double > >::difference_type >(val3);
   try {
@@ -22827,7 +22827,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::difference_type arg2 ;
@@ -22845,27 +22845,27 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setslice____SWIG_1(PyObject
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___setslice__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___setslice__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_t___setslice__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_T___setslice__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::pair< double,double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_pvacuum_double_t___setslice__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_pvacuum_double_T___setslice__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::pair< double,double > >::difference_type >(val3);
   {
     std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > *ptr = (std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > *)0;
     res4 = swig::asptr(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_pvacuum_double_t___setslice__" "', argument " "4"" of type '" "std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_pvacuum_double_T___setslice__" "', argument " "4"" of type '" "std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_t___setslice__" "', argument " "4"" of type '" "std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_T___setslice__" "', argument " "4"" of type '" "std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > const &""'"); 
     }
     arg4 = ptr;
   }
@@ -22885,13 +22885,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___setslice__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t___setslice__", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T___setslice__", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -22908,7 +22908,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setslice__(PyObject *self,
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_pvacuum_double_t___setslice____SWIG_0(self, argc, argv);
+          return _wrap_vector_pvacuum_double_T___setslice____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -22931,7 +22931,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setslice__(PyObject *self,
           int res = swig::asptr(argv[3], (std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > >**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vector_pvacuum_double_t___setslice____SWIG_1(self, argc, argv);
+            return _wrap_vector_pvacuum_double_T___setslice____SWIG_1(self, argc, argv);
           }
         }
       }
@@ -22939,7 +22939,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setslice__(PyObject *self,
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_t___setslice__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_T___setslice__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::pair< double,double > >::__setslice__(std::vector< std::pair< double,double > >::difference_type,std::vector< std::pair< double,double > >::difference_type)\n"
     "    std::vector< std::pair< double,double > >::__setslice__(std::vector< std::pair< double,double > >::difference_type,std::vector< std::pair< double,double > >::difference_type,std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > const &)\n");
@@ -22947,7 +22947,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___delslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___delslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::difference_type arg2 ;
@@ -22961,20 +22961,20 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___delslice__(PyObject *self,
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t___delslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T___delslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___delslice__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___delslice__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_t___delslice__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_T___delslice__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::pair< double,double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_pvacuum_double_t___delslice__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_pvacuum_double_T___delslice__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::pair< double,double > >::difference_type >(val3);
   try {
@@ -22991,7 +22991,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::difference_type arg2 ;
@@ -23004,12 +23004,12 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___delitem____SWIG_0(PyObject
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___delitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___delitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_t___delitem__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_T___delitem__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::pair< double,double > >::difference_type >(val2);
   try {
@@ -23026,7 +23026,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -23038,12 +23038,12 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___getitem____SWIG_0(PyObject
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___getitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___getitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -23061,7 +23061,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -23074,12 +23074,12 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setitem____SWIG_0(PyObject
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___setitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___setitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -23087,10 +23087,10 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setitem____SWIG_0(PyObject
     std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > *ptr = (std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_pvacuum_double_t___setitem__" "', argument " "3"" of type '" "std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_pvacuum_double_T___setitem__" "', argument " "3"" of type '" "std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_t___setitem__" "', argument " "3"" of type '" "std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_T___setitem__" "', argument " "3"" of type '" "std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > const &""'"); 
     }
     arg3 = ptr;
   }
@@ -23110,7 +23110,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -23121,12 +23121,12 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setitem____SWIG_1(PyObject
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___setitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___setitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -23144,7 +23144,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -23155,12 +23155,12 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___delitem____SWIG_1(PyObject
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___delitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___delitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -23178,13 +23178,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___delitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___delitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t___delitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T___delitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -23195,7 +23195,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___delitem__(PyObject *self, P
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_pvacuum_double_t___delitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_pvacuum_double_T___delitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -23209,13 +23209,13 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___delitem__(PyObject *self, P
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_pvacuum_double_t___delitem____SWIG_0(self, argc, argv);
+        return _wrap_vector_pvacuum_double_T___delitem____SWIG_0(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_t___delitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_T___delitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::pair< double,double > >::__delitem__(std::vector< std::pair< double,double > >::difference_type)\n"
     "    std::vector< std::pair< double,double > >::__delitem__(SWIGPY_SLICEOBJECT *)\n");
@@ -23223,7 +23223,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::difference_type arg2 ;
@@ -23237,12 +23237,12 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___getitem____SWIG_1(PyObject
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___getitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___getitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_t___getitem__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_T___getitem__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::pair< double,double > >::difference_type >(val2);
   try {
@@ -23258,13 +23258,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___getitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___getitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t___getitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T___getitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -23275,7 +23275,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___getitem__(PyObject *self, P
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_pvacuum_double_t___getitem____SWIG_0(self, argc, argv);
+        return _wrap_vector_pvacuum_double_T___getitem____SWIG_0(self, argc, argv);
       }
     }
   }
@@ -23289,13 +23289,13 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___getitem__(PyObject *self, P
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_pvacuum_double_t___getitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_pvacuum_double_T___getitem____SWIG_1(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_t___getitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_T___getitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::pair< double,double > >::__getitem__(SWIGPY_SLICEOBJECT *)\n"
     "    std::vector< std::pair< double,double > >::__getitem__(std::vector< std::pair< double,double > >::difference_type) const\n");
@@ -23303,7 +23303,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::difference_type arg2 ;
@@ -23318,22 +23318,22 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setitem____SWIG_2(PyObject
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___setitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___setitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_t___setitem__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_T___setitem__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::pair< double,double > >::difference_type >(val2);
   {
     std::pair< double,double > *ptr = (std::pair< double,double > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_pvacuum_double_t___setitem__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_pvacuum_double_T___setitem__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_t___setitem__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_T___setitem__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -23351,13 +23351,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___setitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t___setitem__", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T___setitem__", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -23368,7 +23368,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setitem__(PyObject *self, P
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_pvacuum_double_t___setitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_pvacuum_double_T___setitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -23384,7 +23384,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setitem__(PyObject *self, P
         int res = swig::asptr(argv[2], (std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vector_pvacuum_double_t___setitem____SWIG_0(self, argc, argv);
+          return _wrap_vector_pvacuum_double_T___setitem____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -23402,14 +23402,14 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setitem__(PyObject *self, P
         int res = swig::asptr(argv[2], (std::pair< double,double >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vector_pvacuum_double_t___setitem____SWIG_2(self, argc, argv);
+          return _wrap_vector_pvacuum_double_T___setitem____SWIG_2(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_t___setitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_T___setitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::pair< double,double > >::__setitem__(SWIGPY_SLICEOBJECT *,std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > const &)\n"
     "    std::vector< std::pair< double,double > >::__setitem__(SWIGPY_SLICEOBJECT *)\n"
@@ -23418,7 +23418,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_pop(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_pop(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -23431,7 +23431,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_pop(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_pop" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_pop" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   try {
@@ -23446,7 +23446,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_append(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_append(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::value_type *arg2 = 0 ;
@@ -23456,20 +23456,20 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_append(PyObject *self, PyObje
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t_append", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T_append", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_append" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_append" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   {
     std::pair< double,double > *ptr = (std::pair< double,double > *)0;
     res2 = swig::asptr(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_pvacuum_double_t_append" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_pvacuum_double_T_append" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_t_append" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_T_append" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -23483,7 +23483,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_t__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
+SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_T__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *result = 0 ;
   
@@ -23497,7 +23497,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_t__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_T__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = 0 ;
   int res1 = SWIG_OLDOBJ ;
@@ -23509,10 +23509,10 @@ SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_t__SWIG_1(PyObject *self, P
     std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > *ptr = (std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > *)0;
     res1 = swig::asptr(swig_obj[0], &ptr);
     if (!SWIG_IsOK(res1)) {
-      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vector_pvacuum_double_t" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vector_pvacuum_double_T" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_pvacuum_double_t" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_pvacuum_double_T" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const &""'"); 
     }
     arg1 = ptr;
   }
@@ -23526,7 +23526,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_empty(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_empty(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -23539,7 +23539,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_empty(PyObject *self, PyObjec
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_empty" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_empty" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = (bool)((std::vector< std::pair< double,double > > const *)arg1)->empty();
@@ -23550,7 +23550,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_size(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_size(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -23563,7 +23563,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_size(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_size" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_size" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = ((std::vector< std::pair< double,double > > const *)arg1)->size();
@@ -23574,7 +23574,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_swap(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_swap(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > > *arg2 = 0 ;
@@ -23585,18 +23585,18 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_swap(PyObject *self, PyObject
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t_swap", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T_swap", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_swap" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_swap" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], &argp2, SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t,  0 );
   if (!SWIG_IsOK(res2)) {
-    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_pvacuum_double_t_swap" "', argument " "2"" of type '" "std::vector< std::pair< double,double > > &""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_pvacuum_double_T_swap" "', argument " "2"" of type '" "std::vector< std::pair< double,double > > &""'"); 
   }
   if (!argp2) {
-    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_t_swap" "', argument " "2"" of type '" "std::vector< std::pair< double,double > > &""'"); 
+    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_T_swap" "', argument " "2"" of type '" "std::vector< std::pair< double,double > > &""'"); 
   }
   arg2 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp2);
   (arg1)->swap(*arg2);
@@ -23607,7 +23607,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_begin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_begin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -23620,7 +23620,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_begin(PyObject *self, PyObjec
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_begin" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_begin" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = (arg1)->begin();
@@ -23632,7 +23632,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_end(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_end(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -23645,7 +23645,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_end(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_end" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_end" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = (arg1)->end();
@@ -23657,7 +23657,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_rbegin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_rbegin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -23670,7 +23670,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_rbegin(PyObject *self, PyObje
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_rbegin" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_rbegin" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = (arg1)->rbegin();
@@ -23682,7 +23682,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_rend(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_rend(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -23695,7 +23695,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_rend(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_rend" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_rend" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = (arg1)->rend();
@@ -23707,7 +23707,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_clear(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_clear(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -23719,7 +23719,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_clear(PyObject *self, PyObjec
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_clear" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_clear" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   (arg1)->clear();
@@ -23730,7 +23730,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_get_allocator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_get_allocator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -23743,7 +23743,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_get_allocator(PyObject *self,
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_get_allocator" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_get_allocator" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = ((std::vector< std::pair< double,double > > const *)arg1)->get_allocator();
@@ -23754,7 +23754,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_t__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_T__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > >::size_type arg1 ;
   size_t val1 ;
@@ -23765,7 +23765,7 @@ SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_t__SWIG_2(PyObject *self, P
   if ((nobjs < 1) || (nobjs > 1)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_pvacuum_double_t" "', argument " "1"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_pvacuum_double_T" "', argument " "1"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
   } 
   arg1 = static_cast< std::vector< std::pair< double,double > >::size_type >(val1);
   result = (std::vector< std::pair< double,double > > *)new std::vector< std::pair< double,double > >(arg1);
@@ -23776,7 +23776,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_pop_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_pop_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -23788,7 +23788,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_pop_back(PyObject *self, PyOb
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_pop_back" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_pop_back" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   (arg1)->pop_back();
@@ -23799,7 +23799,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::size_type arg2 ;
@@ -23812,12 +23812,12 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_resize__SWIG_0(PyObject *self
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_resize" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_resize" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_t_resize" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_T_resize" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::pair< double,double > >::size_type >(val2);
   (arg1)->resize(arg2);
@@ -23828,7 +23828,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::iterator arg2 ;
@@ -23842,18 +23842,18 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_erase__SWIG_0(PyObject *self,
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_erase" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_erase" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t_erase" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T_erase" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t_erase" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T_erase" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
     }
   }
   result = std_vector_Sl_std_pair_Sl_double_Sc_double_Sg__Sg__erase__SWIG_0(arg1,SWIG_STD_MOVE(arg2));
@@ -23865,7 +23865,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::iterator arg2 ;
@@ -23882,29 +23882,29 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_erase__SWIG_1(PyObject *self,
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_erase" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_erase" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t_erase" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T_erase" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t_erase" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T_erase" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
     }
   }
   res3 = SWIG_ConvertPtr(swig_obj[2], SWIG_as_voidptrptr(&iter3), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res3) || !iter3) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t_erase" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T_erase" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *>(iter3);
     if (iter_t) {
       arg3 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t_erase" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T_erase" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
     }
   }
   result = std_vector_Sl_std_pair_Sl_double_Sc_double_Sg__Sg__erase__SWIG_1(arg1,SWIG_STD_MOVE(arg2),SWIG_STD_MOVE(arg3));
@@ -23916,13 +23916,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_erase(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_erase(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t_erase", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T_erase", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -23933,7 +23933,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_erase(PyObject *self, PyObjec
       int res = SWIG_ConvertPtr(argv[1], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
       _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *>(iter) != 0));
       if (_v) {
-        return _wrap_vector_pvacuum_double_t_erase__SWIG_0(self, argc, argv);
+        return _wrap_vector_pvacuum_double_T_erase__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -23950,14 +23950,14 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_erase(PyObject *self, PyObjec
         int res = SWIG_ConvertPtr(argv[2], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
         _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *>(iter) != 0));
         if (_v) {
-          return _wrap_vector_pvacuum_double_t_erase__SWIG_1(self, argc, argv);
+          return _wrap_vector_pvacuum_double_T_erase__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_t_erase'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_T_erase'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::pair< double,double > >::erase(std::vector< std::pair< double,double > >::iterator)\n"
     "    std::vector< std::pair< double,double > >::erase(std::vector< std::pair< double,double > >::iterator,std::vector< std::pair< double,double > >::iterator)\n");
@@ -23965,7 +23965,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_t__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_T__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > >::size_type arg1 ;
   std::vector< std::pair< double,double > >::value_type *arg2 = 0 ;
@@ -23978,17 +23978,17 @@ SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_t__SWIG_3(PyObject *self, P
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_pvacuum_double_t" "', argument " "1"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_pvacuum_double_T" "', argument " "1"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
   } 
   arg1 = static_cast< std::vector< std::pair< double,double > >::size_type >(val1);
   {
     std::pair< double,double > *ptr = (std::pair< double,double > *)0;
     res2 = swig::asptr(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "new_vector_pvacuum_double_t" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "new_vector_pvacuum_double_T" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_pvacuum_double_t" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_pvacuum_double_T" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -24002,16 +24002,16 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_T(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vector_pvacuum_double_t", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vector_pvacuum_double_T", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 0) {
-    return _wrap_new_vector_pvacuum_double_t__SWIG_0(self, argc, argv);
+    return _wrap_new_vector_pvacuum_double_T__SWIG_0(self, argc, argv);
   }
   if (argc == 1) {
     int _v = 0;
@@ -24020,7 +24020,7 @@ SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_t(PyObject *self, PyObject
       _v = SWIG_CheckState(res);
     }
     if (_v) {
-      return _wrap_new_vector_pvacuum_double_t__SWIG_2(self, argc, argv);
+      return _wrap_new_vector_pvacuum_double_T__SWIG_2(self, argc, argv);
     }
   }
   if (argc == 1) {
@@ -24028,7 +24028,7 @@ SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_t(PyObject *self, PyObject
     int res = swig::asptr(argv[0], (std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > >**)(0));
     _v = SWIG_CheckState(res);
     if (_v) {
-      return _wrap_new_vector_pvacuum_double_t__SWIG_1(self, argc, argv);
+      return _wrap_new_vector_pvacuum_double_T__SWIG_1(self, argc, argv);
     }
   }
   if (argc == 2) {
@@ -24041,13 +24041,13 @@ SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_t(PyObject *self, PyObject
       int res = swig::asptr(argv[1], (std::pair< double,double >**)(0));
       _v = SWIG_CheckState(res);
       if (_v) {
-        return _wrap_new_vector_pvacuum_double_t__SWIG_3(self, argc, argv);
+        return _wrap_new_vector_pvacuum_double_T__SWIG_3(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vector_pvacuum_double_t'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vector_pvacuum_double_T'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::pair< double,double > >::vector()\n"
     "    std::vector< std::pair< double,double > >::vector(std::vector< std::pair< double,double > > const &)\n"
@@ -24057,7 +24057,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_push_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_push_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::value_type *arg2 = 0 ;
@@ -24067,20 +24067,20 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_push_back(PyObject *self, PyO
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t_push_back", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T_push_back", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_push_back" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_push_back" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   {
     std::pair< double,double > *ptr = (std::pair< double,double > *)0;
     res2 = swig::asptr(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_pvacuum_double_t_push_back" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_pvacuum_double_T_push_back" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_t_push_back" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_T_push_back" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -24094,7 +24094,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_front(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_front(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -24107,7 +24107,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_front(PyObject *self, PyObjec
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_front" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_front" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = (std::vector< std::pair< double,double > >::value_type *) &((std::vector< std::pair< double,double > > const *)arg1)->front();
@@ -24119,7 +24119,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -24132,7 +24132,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_back(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_back" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_back" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = (std::vector< std::pair< double,double > >::value_type *) &((std::vector< std::pair< double,double > > const *)arg1)->back();
@@ -24144,7 +24144,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_assign(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_assign(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::size_type arg2 ;
@@ -24157,25 +24157,25 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_assign(PyObject *self, PyObje
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t_assign", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T_assign", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_assign" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_assign" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_t_assign" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_T_assign" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::pair< double,double > >::size_type >(val2);
   {
     std::pair< double,double > *ptr = (std::pair< double,double > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_pvacuum_double_t_assign" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_pvacuum_double_T_assign" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_t_assign" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_T_assign" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -24189,7 +24189,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::size_type arg2 ;
@@ -24204,22 +24204,22 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_resize__SWIG_1(PyObject *self
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_resize" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_resize" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_t_resize" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_T_resize" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::pair< double,double > >::size_type >(val2);
   {
     std::pair< double,double > *ptr = (std::pair< double,double > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_pvacuum_double_t_resize" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_pvacuum_double_T_resize" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_t_resize" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_T_resize" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -24233,13 +24233,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_resize(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_resize(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t_resize", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T_resize", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -24251,7 +24251,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_resize(PyObject *self, PyObje
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_pvacuum_double_t_resize__SWIG_0(self, argc, argv);
+        return _wrap_vector_pvacuum_double_T_resize__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -24268,14 +24268,14 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_resize(PyObject *self, PyObje
         int res = swig::asptr(argv[2], (std::pair< double,double >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vector_pvacuum_double_t_resize__SWIG_1(self, argc, argv);
+          return _wrap_vector_pvacuum_double_T_resize__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_t_resize'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_T_resize'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::pair< double,double > >::resize(std::vector< std::pair< double,double > >::size_type)\n"
     "    std::vector< std::pair< double,double > >::resize(std::vector< std::pair< double,double > >::size_type,std::vector< std::pair< double,double > >::value_type const &)\n");
@@ -24283,7 +24283,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::iterator arg2 ;
@@ -24299,28 +24299,28 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_insert__SWIG_0(PyObject *self
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_insert" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_insert" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t_insert" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T_insert" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t_insert" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T_insert" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
     }
   }
   {
     std::pair< double,double > *ptr = (std::pair< double,double > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_pvacuum_double_t_insert" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_pvacuum_double_T_insert" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_t_insert" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_T_insert" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -24335,7 +24335,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::iterator arg2 ;
@@ -24353,33 +24353,33 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_insert__SWIG_1(PyObject *self
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_insert" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_insert" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t_insert" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T_insert" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t_insert" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T_insert" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_size_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_pvacuum_double_t_insert" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_pvacuum_double_T_insert" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
   } 
   arg3 = static_cast< std::vector< std::pair< double,double > >::size_type >(val3);
   {
     std::pair< double,double > *ptr = (std::pair< double,double > *)0;
     res4 = swig::asptr(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_pvacuum_double_t_insert" "', argument " "4"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_pvacuum_double_T_insert" "', argument " "4"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_t_insert" "', argument " "4"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_T_insert" "', argument " "4"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     arg4 = ptr;
   }
@@ -24393,13 +24393,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_insert(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_insert(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t_insert", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T_insert", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -24413,7 +24413,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_insert(PyObject *self, PyObje
         int res = swig::asptr(argv[2], (std::pair< double,double >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vector_pvacuum_double_t_insert__SWIG_0(self, argc, argv);
+          return _wrap_vector_pvacuum_double_T_insert__SWIG_0(self, argc, argv);
         }
       }
     }
@@ -24435,7 +24435,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_insert(PyObject *self, PyObje
           int res = swig::asptr(argv[3], (std::pair< double,double >**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vector_pvacuum_double_t_insert__SWIG_1(self, argc, argv);
+            return _wrap_vector_pvacuum_double_T_insert__SWIG_1(self, argc, argv);
           }
         }
       }
@@ -24443,7 +24443,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_insert(PyObject *self, PyObje
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_t_insert'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_T_insert'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::pair< double,double > >::insert(std::vector< std::pair< double,double > >::iterator,std::vector< std::pair< double,double > >::value_type const &)\n"
     "    std::vector< std::pair< double,double > >::insert(std::vector< std::pair< double,double > >::iterator,std::vector< std::pair< double,double > >::size_type,std::vector< std::pair< double,double > >::value_type const &)\n");
@@ -24451,7 +24451,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_reserve(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_reserve(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::size_type arg2 ;
@@ -24462,15 +24462,15 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_reserve(PyObject *self, PyObj
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t_reserve", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T_reserve", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_reserve" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_reserve" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_t_reserve" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_T_reserve" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::pair< double,double > >::size_type >(val2);
   (arg1)->reserve(arg2);
@@ -24481,7 +24481,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_capacity(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_capacity(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -24494,7 +24494,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_capacity(PyObject *self, PyOb
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_capacity" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_capacity" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = ((std::vector< std::pair< double,double > > const *)arg1)->capacity();
@@ -24505,7 +24505,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_delete_vector_pvacuum_double_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_delete_vector_pvacuum_double_T(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -24517,7 +24517,7 @@ SWIGINTERN PyObject *_wrap_delete_vector_pvacuum_double_t(PyObject *self, PyObje
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, SWIG_POINTER_DISOWN |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vector_pvacuum_double_t" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vector_pvacuum_double_T" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   {
@@ -24538,14 +24538,14 @@ fail:
 }
 
 
-SWIGINTERN PyObject *vector_pvacuum_double_t_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vector_pvacuum_double_T_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   PyObject *obj;
   if (!SWIG_Python_UnpackTuple(args, "swigregister", 1, 1, &obj)) return NULL;
   SWIG_TypeNewClientData(SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, SWIG_NewClientData(obj));
   return SWIG_Py_Void();
 }
 
-SWIGINTERN PyObject *vector_pvacuum_double_t_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vector_pvacuum_double_T_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   return SWIG_Python_InitShadowInstance(args);
 }
 
@@ -29997,558 +29997,558 @@ static PyMethodDef SwigMethods[] = {
 		"SwigPyIterator___sub__(SwigPyIterator self, SwigPyIterator x) -> ptrdiff_t\n"
 		""},
 	 { "SwigPyIterator_swigregister", SwigPyIterator_swigregister, METH_O, NULL},
-	 { "vdouble1d_t_iterator", _wrap_vdouble1d_t_iterator, METH_O, "vdouble1d_t_iterator(vdouble1d_t self) -> SwigPyIterator"},
-	 { "vdouble1d_t___nonzero__", _wrap_vdouble1d_t___nonzero__, METH_O, "vdouble1d_t___nonzero__(vdouble1d_t self) -> bool"},
-	 { "vdouble1d_t___bool__", _wrap_vdouble1d_t___bool__, METH_O, "vdouble1d_t___bool__(vdouble1d_t self) -> bool"},
-	 { "vdouble1d_t___len__", _wrap_vdouble1d_t___len__, METH_O, "vdouble1d_t___len__(vdouble1d_t self) -> std::vector< double >::size_type"},
-	 { "vdouble1d_t___getslice__", _wrap_vdouble1d_t___getslice__, METH_VARARGS, "vdouble1d_t___getslice__(vdouble1d_t self, std::vector< double >::difference_type i, std::vector< double >::difference_type j) -> vdouble1d_t"},
-	 { "vdouble1d_t___setslice__", _wrap_vdouble1d_t___setslice__, METH_VARARGS, "\n"
-		"vdouble1d_t___setslice__(vdouble1d_t self, std::vector< double >::difference_type i, std::vector< double >::difference_type j)\n"
-		"vdouble1d_t___setslice__(vdouble1d_t self, std::vector< double >::difference_type i, std::vector< double >::difference_type j, vdouble1d_t v)\n"
+	 { "vdouble1d_T_iterator", _wrap_vdouble1d_T_iterator, METH_O, "vdouble1d_T_iterator(vdouble1d_T self) -> SwigPyIterator"},
+	 { "vdouble1d_T___nonzero__", _wrap_vdouble1d_T___nonzero__, METH_O, "vdouble1d_T___nonzero__(vdouble1d_T self) -> bool"},
+	 { "vdouble1d_T___bool__", _wrap_vdouble1d_T___bool__, METH_O, "vdouble1d_T___bool__(vdouble1d_T self) -> bool"},
+	 { "vdouble1d_T___len__", _wrap_vdouble1d_T___len__, METH_O, "vdouble1d_T___len__(vdouble1d_T self) -> std::vector< double >::size_type"},
+	 { "vdouble1d_T___getslice__", _wrap_vdouble1d_T___getslice__, METH_VARARGS, "vdouble1d_T___getslice__(vdouble1d_T self, std::vector< double >::difference_type i, std::vector< double >::difference_type j) -> vdouble1d_T"},
+	 { "vdouble1d_T___setslice__", _wrap_vdouble1d_T___setslice__, METH_VARARGS, "\n"
+		"vdouble1d_T___setslice__(vdouble1d_T self, std::vector< double >::difference_type i, std::vector< double >::difference_type j)\n"
+		"vdouble1d_T___setslice__(vdouble1d_T self, std::vector< double >::difference_type i, std::vector< double >::difference_type j, vdouble1d_T v)\n"
 		""},
-	 { "vdouble1d_t___delslice__", _wrap_vdouble1d_t___delslice__, METH_VARARGS, "vdouble1d_t___delslice__(vdouble1d_t self, std::vector< double >::difference_type i, std::vector< double >::difference_type j)"},
-	 { "vdouble1d_t___delitem__", _wrap_vdouble1d_t___delitem__, METH_VARARGS, "\n"
-		"vdouble1d_t___delitem__(vdouble1d_t self, std::vector< double >::difference_type i)\n"
-		"vdouble1d_t___delitem__(vdouble1d_t self, SWIGPY_SLICEOBJECT * slice)\n"
+	 { "vdouble1d_T___delslice__", _wrap_vdouble1d_T___delslice__, METH_VARARGS, "vdouble1d_T___delslice__(vdouble1d_T self, std::vector< double >::difference_type i, std::vector< double >::difference_type j)"},
+	 { "vdouble1d_T___delitem__", _wrap_vdouble1d_T___delitem__, METH_VARARGS, "\n"
+		"vdouble1d_T___delitem__(vdouble1d_T self, std::vector< double >::difference_type i)\n"
+		"vdouble1d_T___delitem__(vdouble1d_T self, SWIGPY_SLICEOBJECT * slice)\n"
 		""},
-	 { "vdouble1d_t___getitem__", _wrap_vdouble1d_t___getitem__, METH_VARARGS, "\n"
-		"vdouble1d_t___getitem__(vdouble1d_t self, SWIGPY_SLICEOBJECT * slice) -> vdouble1d_t\n"
-		"vdouble1d_t___getitem__(vdouble1d_t self, std::vector< double >::difference_type i) -> std::vector< double >::value_type const &\n"
+	 { "vdouble1d_T___getitem__", _wrap_vdouble1d_T___getitem__, METH_VARARGS, "\n"
+		"vdouble1d_T___getitem__(vdouble1d_T self, SWIGPY_SLICEOBJECT * slice) -> vdouble1d_T\n"
+		"vdouble1d_T___getitem__(vdouble1d_T self, std::vector< double >::difference_type i) -> std::vector< double >::value_type const &\n"
 		""},
-	 { "vdouble1d_t___setitem__", _wrap_vdouble1d_t___setitem__, METH_VARARGS, "\n"
-		"vdouble1d_t___setitem__(vdouble1d_t self, SWIGPY_SLICEOBJECT * slice, vdouble1d_t v)\n"
-		"vdouble1d_t___setitem__(vdouble1d_t self, SWIGPY_SLICEOBJECT * slice)\n"
-		"vdouble1d_t___setitem__(vdouble1d_t self, std::vector< double >::difference_type i, std::vector< double >::value_type const & x)\n"
+	 { "vdouble1d_T___setitem__", _wrap_vdouble1d_T___setitem__, METH_VARARGS, "\n"
+		"vdouble1d_T___setitem__(vdouble1d_T self, SWIGPY_SLICEOBJECT * slice, vdouble1d_T v)\n"
+		"vdouble1d_T___setitem__(vdouble1d_T self, SWIGPY_SLICEOBJECT * slice)\n"
+		"vdouble1d_T___setitem__(vdouble1d_T self, std::vector< double >::difference_type i, std::vector< double >::value_type const & x)\n"
 		""},
-	 { "vdouble1d_t_pop", _wrap_vdouble1d_t_pop, METH_O, "vdouble1d_t_pop(vdouble1d_t self) -> std::vector< double >::value_type"},
-	 { "vdouble1d_t_append", _wrap_vdouble1d_t_append, METH_VARARGS, "vdouble1d_t_append(vdouble1d_t self, std::vector< double >::value_type const & x)"},
-	 { "vdouble1d_t_empty", _wrap_vdouble1d_t_empty, METH_O, "vdouble1d_t_empty(vdouble1d_t self) -> bool"},
-	 { "vdouble1d_t_size", _wrap_vdouble1d_t_size, METH_O, "vdouble1d_t_size(vdouble1d_t self) -> std::vector< double >::size_type"},
-	 { "vdouble1d_t_swap", _wrap_vdouble1d_t_swap, METH_VARARGS, "vdouble1d_t_swap(vdouble1d_t self, vdouble1d_t v)"},
-	 { "vdouble1d_t_begin", _wrap_vdouble1d_t_begin, METH_O, "vdouble1d_t_begin(vdouble1d_t self) -> std::vector< double >::iterator"},
-	 { "vdouble1d_t_end", _wrap_vdouble1d_t_end, METH_O, "vdouble1d_t_end(vdouble1d_t self) -> std::vector< double >::iterator"},
-	 { "vdouble1d_t_rbegin", _wrap_vdouble1d_t_rbegin, METH_O, "vdouble1d_t_rbegin(vdouble1d_t self) -> std::vector< double >::reverse_iterator"},
-	 { "vdouble1d_t_rend", _wrap_vdouble1d_t_rend, METH_O, "vdouble1d_t_rend(vdouble1d_t self) -> std::vector< double >::reverse_iterator"},
-	 { "vdouble1d_t_clear", _wrap_vdouble1d_t_clear, METH_O, "vdouble1d_t_clear(vdouble1d_t self)"},
-	 { "vdouble1d_t_get_allocator", _wrap_vdouble1d_t_get_allocator, METH_O, "vdouble1d_t_get_allocator(vdouble1d_t self) -> std::vector< double >::allocator_type"},
-	 { "vdouble1d_t_pop_back", _wrap_vdouble1d_t_pop_back, METH_O, "vdouble1d_t_pop_back(vdouble1d_t self)"},
-	 { "vdouble1d_t_erase", _wrap_vdouble1d_t_erase, METH_VARARGS, "\n"
-		"vdouble1d_t_erase(vdouble1d_t self, std::vector< double >::iterator pos) -> std::vector< double >::iterator\n"
-		"vdouble1d_t_erase(vdouble1d_t self, std::vector< double >::iterator first, std::vector< double >::iterator last) -> std::vector< double >::iterator\n"
+	 { "vdouble1d_T_pop", _wrap_vdouble1d_T_pop, METH_O, "vdouble1d_T_pop(vdouble1d_T self) -> std::vector< double >::value_type"},
+	 { "vdouble1d_T_append", _wrap_vdouble1d_T_append, METH_VARARGS, "vdouble1d_T_append(vdouble1d_T self, std::vector< double >::value_type const & x)"},
+	 { "vdouble1d_T_empty", _wrap_vdouble1d_T_empty, METH_O, "vdouble1d_T_empty(vdouble1d_T self) -> bool"},
+	 { "vdouble1d_T_size", _wrap_vdouble1d_T_size, METH_O, "vdouble1d_T_size(vdouble1d_T self) -> std::vector< double >::size_type"},
+	 { "vdouble1d_T_swap", _wrap_vdouble1d_T_swap, METH_VARARGS, "vdouble1d_T_swap(vdouble1d_T self, vdouble1d_T v)"},
+	 { "vdouble1d_T_begin", _wrap_vdouble1d_T_begin, METH_O, "vdouble1d_T_begin(vdouble1d_T self) -> std::vector< double >::iterator"},
+	 { "vdouble1d_T_end", _wrap_vdouble1d_T_end, METH_O, "vdouble1d_T_end(vdouble1d_T self) -> std::vector< double >::iterator"},
+	 { "vdouble1d_T_rbegin", _wrap_vdouble1d_T_rbegin, METH_O, "vdouble1d_T_rbegin(vdouble1d_T self) -> std::vector< double >::reverse_iterator"},
+	 { "vdouble1d_T_rend", _wrap_vdouble1d_T_rend, METH_O, "vdouble1d_T_rend(vdouble1d_T self) -> std::vector< double >::reverse_iterator"},
+	 { "vdouble1d_T_clear", _wrap_vdouble1d_T_clear, METH_O, "vdouble1d_T_clear(vdouble1d_T self)"},
+	 { "vdouble1d_T_get_allocator", _wrap_vdouble1d_T_get_allocator, METH_O, "vdouble1d_T_get_allocator(vdouble1d_T self) -> std::vector< double >::allocator_type"},
+	 { "vdouble1d_T_pop_back", _wrap_vdouble1d_T_pop_back, METH_O, "vdouble1d_T_pop_back(vdouble1d_T self)"},
+	 { "vdouble1d_T_erase", _wrap_vdouble1d_T_erase, METH_VARARGS, "\n"
+		"vdouble1d_T_erase(vdouble1d_T self, std::vector< double >::iterator pos) -> std::vector< double >::iterator\n"
+		"vdouble1d_T_erase(vdouble1d_T self, std::vector< double >::iterator first, std::vector< double >::iterator last) -> std::vector< double >::iterator\n"
 		""},
-	 { "new_vdouble1d_t", _wrap_new_vdouble1d_t, METH_VARARGS, "\n"
-		"vdouble1d_t()\n"
-		"vdouble1d_t(vdouble1d_t other)\n"
-		"vdouble1d_t(std::vector< double >::size_type size)\n"
-		"new_vdouble1d_t(std::vector< double >::size_type size, std::vector< double >::value_type const & value) -> vdouble1d_t\n"
+	 { "new_vdouble1d_T", _wrap_new_vdouble1d_T, METH_VARARGS, "\n"
+		"vdouble1d_T()\n"
+		"vdouble1d_T(vdouble1d_T other)\n"
+		"vdouble1d_T(std::vector< double >::size_type size)\n"
+		"new_vdouble1d_T(std::vector< double >::size_type size, std::vector< double >::value_type const & value) -> vdouble1d_T\n"
 		""},
-	 { "vdouble1d_t_push_back", _wrap_vdouble1d_t_push_back, METH_VARARGS, "vdouble1d_t_push_back(vdouble1d_t self, std::vector< double >::value_type const & x)"},
-	 { "vdouble1d_t_front", _wrap_vdouble1d_t_front, METH_O, "vdouble1d_t_front(vdouble1d_t self) -> std::vector< double >::value_type const &"},
-	 { "vdouble1d_t_back", _wrap_vdouble1d_t_back, METH_O, "vdouble1d_t_back(vdouble1d_t self) -> std::vector< double >::value_type const &"},
-	 { "vdouble1d_t_assign", _wrap_vdouble1d_t_assign, METH_VARARGS, "vdouble1d_t_assign(vdouble1d_t self, std::vector< double >::size_type n, std::vector< double >::value_type const & x)"},
-	 { "vdouble1d_t_resize", _wrap_vdouble1d_t_resize, METH_VARARGS, "\n"
-		"vdouble1d_t_resize(vdouble1d_t self, std::vector< double >::size_type new_size)\n"
-		"vdouble1d_t_resize(vdouble1d_t self, std::vector< double >::size_type new_size, std::vector< double >::value_type const & x)\n"
+	 { "vdouble1d_T_push_back", _wrap_vdouble1d_T_push_back, METH_VARARGS, "vdouble1d_T_push_back(vdouble1d_T self, std::vector< double >::value_type const & x)"},
+	 { "vdouble1d_T_front", _wrap_vdouble1d_T_front, METH_O, "vdouble1d_T_front(vdouble1d_T self) -> std::vector< double >::value_type const &"},
+	 { "vdouble1d_T_back", _wrap_vdouble1d_T_back, METH_O, "vdouble1d_T_back(vdouble1d_T self) -> std::vector< double >::value_type const &"},
+	 { "vdouble1d_T_assign", _wrap_vdouble1d_T_assign, METH_VARARGS, "vdouble1d_T_assign(vdouble1d_T self, std::vector< double >::size_type n, std::vector< double >::value_type const & x)"},
+	 { "vdouble1d_T_resize", _wrap_vdouble1d_T_resize, METH_VARARGS, "\n"
+		"vdouble1d_T_resize(vdouble1d_T self, std::vector< double >::size_type new_size)\n"
+		"vdouble1d_T_resize(vdouble1d_T self, std::vector< double >::size_type new_size, std::vector< double >::value_type const & x)\n"
 		""},
-	 { "vdouble1d_t_insert", _wrap_vdouble1d_t_insert, METH_VARARGS, "\n"
-		"vdouble1d_t_insert(vdouble1d_t self, std::vector< double >::iterator pos, std::vector< double >::value_type const & x) -> std::vector< double >::iterator\n"
-		"vdouble1d_t_insert(vdouble1d_t self, std::vector< double >::iterator pos, std::vector< double >::size_type n, std::vector< double >::value_type const & x)\n"
+	 { "vdouble1d_T_insert", _wrap_vdouble1d_T_insert, METH_VARARGS, "\n"
+		"vdouble1d_T_insert(vdouble1d_T self, std::vector< double >::iterator pos, std::vector< double >::value_type const & x) -> std::vector< double >::iterator\n"
+		"vdouble1d_T_insert(vdouble1d_T self, std::vector< double >::iterator pos, std::vector< double >::size_type n, std::vector< double >::value_type const & x)\n"
 		""},
-	 { "vdouble1d_t_reserve", _wrap_vdouble1d_t_reserve, METH_VARARGS, "vdouble1d_t_reserve(vdouble1d_t self, std::vector< double >::size_type n)"},
-	 { "vdouble1d_t_capacity", _wrap_vdouble1d_t_capacity, METH_O, "vdouble1d_t_capacity(vdouble1d_t self) -> std::vector< double >::size_type"},
-	 { "delete_vdouble1d_t", _wrap_delete_vdouble1d_t, METH_O, "delete_vdouble1d_t(vdouble1d_t self)"},
-	 { "vdouble1d_t_swigregister", vdouble1d_t_swigregister, METH_O, NULL},
-	 { "vdouble1d_t_swiginit", vdouble1d_t_swiginit, METH_VARARGS, NULL},
-	 { "vdouble2d_t_iterator", _wrap_vdouble2d_t_iterator, METH_O, "vdouble2d_t_iterator(vdouble2d_t self) -> SwigPyIterator"},
-	 { "vdouble2d_t___nonzero__", _wrap_vdouble2d_t___nonzero__, METH_O, "vdouble2d_t___nonzero__(vdouble2d_t self) -> bool"},
-	 { "vdouble2d_t___bool__", _wrap_vdouble2d_t___bool__, METH_O, "vdouble2d_t___bool__(vdouble2d_t self) -> bool"},
-	 { "vdouble2d_t___len__", _wrap_vdouble2d_t___len__, METH_O, "vdouble2d_t___len__(vdouble2d_t self) -> std::vector< std::vector< double > >::size_type"},
-	 { "vdouble2d_t___getslice__", _wrap_vdouble2d_t___getslice__, METH_VARARGS, "vdouble2d_t___getslice__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j) -> vdouble2d_t"},
-	 { "vdouble2d_t___setslice__", _wrap_vdouble2d_t___setslice__, METH_VARARGS, "\n"
-		"vdouble2d_t___setslice__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j)\n"
-		"vdouble2d_t___setslice__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j, vdouble2d_t v)\n"
+	 { "vdouble1d_T_reserve", _wrap_vdouble1d_T_reserve, METH_VARARGS, "vdouble1d_T_reserve(vdouble1d_T self, std::vector< double >::size_type n)"},
+	 { "vdouble1d_T_capacity", _wrap_vdouble1d_T_capacity, METH_O, "vdouble1d_T_capacity(vdouble1d_T self) -> std::vector< double >::size_type"},
+	 { "delete_vdouble1d_T", _wrap_delete_vdouble1d_T, METH_O, "delete_vdouble1d_T(vdouble1d_T self)"},
+	 { "vdouble1d_T_swigregister", vdouble1d_T_swigregister, METH_O, NULL},
+	 { "vdouble1d_T_swiginit", vdouble1d_T_swiginit, METH_VARARGS, NULL},
+	 { "vdouble2d_T_iterator", _wrap_vdouble2d_T_iterator, METH_O, "vdouble2d_T_iterator(vdouble2d_T self) -> SwigPyIterator"},
+	 { "vdouble2d_T___nonzero__", _wrap_vdouble2d_T___nonzero__, METH_O, "vdouble2d_T___nonzero__(vdouble2d_T self) -> bool"},
+	 { "vdouble2d_T___bool__", _wrap_vdouble2d_T___bool__, METH_O, "vdouble2d_T___bool__(vdouble2d_T self) -> bool"},
+	 { "vdouble2d_T___len__", _wrap_vdouble2d_T___len__, METH_O, "vdouble2d_T___len__(vdouble2d_T self) -> std::vector< std::vector< double > >::size_type"},
+	 { "vdouble2d_T___getslice__", _wrap_vdouble2d_T___getslice__, METH_VARARGS, "vdouble2d_T___getslice__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j) -> vdouble2d_T"},
+	 { "vdouble2d_T___setslice__", _wrap_vdouble2d_T___setslice__, METH_VARARGS, "\n"
+		"vdouble2d_T___setslice__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j)\n"
+		"vdouble2d_T___setslice__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j, vdouble2d_T v)\n"
 		""},
-	 { "vdouble2d_t___delslice__", _wrap_vdouble2d_t___delslice__, METH_VARARGS, "vdouble2d_t___delslice__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j)"},
-	 { "vdouble2d_t___delitem__", _wrap_vdouble2d_t___delitem__, METH_VARARGS, "\n"
-		"vdouble2d_t___delitem__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i)\n"
-		"vdouble2d_t___delitem__(vdouble2d_t self, SWIGPY_SLICEOBJECT * slice)\n"
+	 { "vdouble2d_T___delslice__", _wrap_vdouble2d_T___delslice__, METH_VARARGS, "vdouble2d_T___delslice__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j)"},
+	 { "vdouble2d_T___delitem__", _wrap_vdouble2d_T___delitem__, METH_VARARGS, "\n"
+		"vdouble2d_T___delitem__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i)\n"
+		"vdouble2d_T___delitem__(vdouble2d_T self, SWIGPY_SLICEOBJECT * slice)\n"
 		""},
-	 { "vdouble2d_t___getitem__", _wrap_vdouble2d_t___getitem__, METH_VARARGS, "\n"
-		"vdouble2d_t___getitem__(vdouble2d_t self, SWIGPY_SLICEOBJECT * slice) -> vdouble2d_t\n"
-		"vdouble2d_t___getitem__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i) -> vdouble1d_t\n"
+	 { "vdouble2d_T___getitem__", _wrap_vdouble2d_T___getitem__, METH_VARARGS, "\n"
+		"vdouble2d_T___getitem__(vdouble2d_T self, SWIGPY_SLICEOBJECT * slice) -> vdouble2d_T\n"
+		"vdouble2d_T___getitem__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i) -> vdouble1d_T\n"
 		""},
-	 { "vdouble2d_t___setitem__", _wrap_vdouble2d_t___setitem__, METH_VARARGS, "\n"
-		"vdouble2d_t___setitem__(vdouble2d_t self, SWIGPY_SLICEOBJECT * slice, vdouble2d_t v)\n"
-		"vdouble2d_t___setitem__(vdouble2d_t self, SWIGPY_SLICEOBJECT * slice)\n"
-		"vdouble2d_t___setitem__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i, vdouble1d_t x)\n"
+	 { "vdouble2d_T___setitem__", _wrap_vdouble2d_T___setitem__, METH_VARARGS, "\n"
+		"vdouble2d_T___setitem__(vdouble2d_T self, SWIGPY_SLICEOBJECT * slice, vdouble2d_T v)\n"
+		"vdouble2d_T___setitem__(vdouble2d_T self, SWIGPY_SLICEOBJECT * slice)\n"
+		"vdouble2d_T___setitem__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i, vdouble1d_T x)\n"
 		""},
-	 { "vdouble2d_t_pop", _wrap_vdouble2d_t_pop, METH_O, "vdouble2d_t_pop(vdouble2d_t self) -> vdouble1d_t"},
-	 { "vdouble2d_t_append", _wrap_vdouble2d_t_append, METH_VARARGS, "vdouble2d_t_append(vdouble2d_t self, vdouble1d_t x)"},
-	 { "vdouble2d_t_empty", _wrap_vdouble2d_t_empty, METH_O, "vdouble2d_t_empty(vdouble2d_t self) -> bool"},
-	 { "vdouble2d_t_size", _wrap_vdouble2d_t_size, METH_O, "vdouble2d_t_size(vdouble2d_t self) -> std::vector< std::vector< double > >::size_type"},
-	 { "vdouble2d_t_swap", _wrap_vdouble2d_t_swap, METH_VARARGS, "vdouble2d_t_swap(vdouble2d_t self, vdouble2d_t v)"},
-	 { "vdouble2d_t_begin", _wrap_vdouble2d_t_begin, METH_O, "vdouble2d_t_begin(vdouble2d_t self) -> std::vector< std::vector< double > >::iterator"},
-	 { "vdouble2d_t_end", _wrap_vdouble2d_t_end, METH_O, "vdouble2d_t_end(vdouble2d_t self) -> std::vector< std::vector< double > >::iterator"},
-	 { "vdouble2d_t_rbegin", _wrap_vdouble2d_t_rbegin, METH_O, "vdouble2d_t_rbegin(vdouble2d_t self) -> std::vector< std::vector< double > >::reverse_iterator"},
-	 { "vdouble2d_t_rend", _wrap_vdouble2d_t_rend, METH_O, "vdouble2d_t_rend(vdouble2d_t self) -> std::vector< std::vector< double > >::reverse_iterator"},
-	 { "vdouble2d_t_clear", _wrap_vdouble2d_t_clear, METH_O, "vdouble2d_t_clear(vdouble2d_t self)"},
-	 { "vdouble2d_t_get_allocator", _wrap_vdouble2d_t_get_allocator, METH_O, "vdouble2d_t_get_allocator(vdouble2d_t self) -> std::vector< std::vector< double > >::allocator_type"},
-	 { "vdouble2d_t_pop_back", _wrap_vdouble2d_t_pop_back, METH_O, "vdouble2d_t_pop_back(vdouble2d_t self)"},
-	 { "vdouble2d_t_erase", _wrap_vdouble2d_t_erase, METH_VARARGS, "\n"
-		"vdouble2d_t_erase(vdouble2d_t self, std::vector< std::vector< double > >::iterator pos) -> std::vector< std::vector< double > >::iterator\n"
-		"vdouble2d_t_erase(vdouble2d_t self, std::vector< std::vector< double > >::iterator first, std::vector< std::vector< double > >::iterator last) -> std::vector< std::vector< double > >::iterator\n"
+	 { "vdouble2d_T_pop", _wrap_vdouble2d_T_pop, METH_O, "vdouble2d_T_pop(vdouble2d_T self) -> vdouble1d_T"},
+	 { "vdouble2d_T_append", _wrap_vdouble2d_T_append, METH_VARARGS, "vdouble2d_T_append(vdouble2d_T self, vdouble1d_T x)"},
+	 { "vdouble2d_T_empty", _wrap_vdouble2d_T_empty, METH_O, "vdouble2d_T_empty(vdouble2d_T self) -> bool"},
+	 { "vdouble2d_T_size", _wrap_vdouble2d_T_size, METH_O, "vdouble2d_T_size(vdouble2d_T self) -> std::vector< std::vector< double > >::size_type"},
+	 { "vdouble2d_T_swap", _wrap_vdouble2d_T_swap, METH_VARARGS, "vdouble2d_T_swap(vdouble2d_T self, vdouble2d_T v)"},
+	 { "vdouble2d_T_begin", _wrap_vdouble2d_T_begin, METH_O, "vdouble2d_T_begin(vdouble2d_T self) -> std::vector< std::vector< double > >::iterator"},
+	 { "vdouble2d_T_end", _wrap_vdouble2d_T_end, METH_O, "vdouble2d_T_end(vdouble2d_T self) -> std::vector< std::vector< double > >::iterator"},
+	 { "vdouble2d_T_rbegin", _wrap_vdouble2d_T_rbegin, METH_O, "vdouble2d_T_rbegin(vdouble2d_T self) -> std::vector< std::vector< double > >::reverse_iterator"},
+	 { "vdouble2d_T_rend", _wrap_vdouble2d_T_rend, METH_O, "vdouble2d_T_rend(vdouble2d_T self) -> std::vector< std::vector< double > >::reverse_iterator"},
+	 { "vdouble2d_T_clear", _wrap_vdouble2d_T_clear, METH_O, "vdouble2d_T_clear(vdouble2d_T self)"},
+	 { "vdouble2d_T_get_allocator", _wrap_vdouble2d_T_get_allocator, METH_O, "vdouble2d_T_get_allocator(vdouble2d_T self) -> std::vector< std::vector< double > >::allocator_type"},
+	 { "vdouble2d_T_pop_back", _wrap_vdouble2d_T_pop_back, METH_O, "vdouble2d_T_pop_back(vdouble2d_T self)"},
+	 { "vdouble2d_T_erase", _wrap_vdouble2d_T_erase, METH_VARARGS, "\n"
+		"vdouble2d_T_erase(vdouble2d_T self, std::vector< std::vector< double > >::iterator pos) -> std::vector< std::vector< double > >::iterator\n"
+		"vdouble2d_T_erase(vdouble2d_T self, std::vector< std::vector< double > >::iterator first, std::vector< std::vector< double > >::iterator last) -> std::vector< std::vector< double > >::iterator\n"
 		""},
-	 { "new_vdouble2d_t", _wrap_new_vdouble2d_t, METH_VARARGS, "\n"
-		"vdouble2d_t()\n"
-		"vdouble2d_t(vdouble2d_t other)\n"
-		"vdouble2d_t(std::vector< std::vector< double > >::size_type size)\n"
-		"new_vdouble2d_t(std::vector< std::vector< double > >::size_type size, vdouble1d_t value) -> vdouble2d_t\n"
+	 { "new_vdouble2d_T", _wrap_new_vdouble2d_T, METH_VARARGS, "\n"
+		"vdouble2d_T()\n"
+		"vdouble2d_T(vdouble2d_T other)\n"
+		"vdouble2d_T(std::vector< std::vector< double > >::size_type size)\n"
+		"new_vdouble2d_T(std::vector< std::vector< double > >::size_type size, vdouble1d_T value) -> vdouble2d_T\n"
 		""},
-	 { "vdouble2d_t_push_back", _wrap_vdouble2d_t_push_back, METH_VARARGS, "vdouble2d_t_push_back(vdouble2d_t self, vdouble1d_t x)"},
-	 { "vdouble2d_t_front", _wrap_vdouble2d_t_front, METH_O, "vdouble2d_t_front(vdouble2d_t self) -> vdouble1d_t"},
-	 { "vdouble2d_t_back", _wrap_vdouble2d_t_back, METH_O, "vdouble2d_t_back(vdouble2d_t self) -> vdouble1d_t"},
-	 { "vdouble2d_t_assign", _wrap_vdouble2d_t_assign, METH_VARARGS, "vdouble2d_t_assign(vdouble2d_t self, std::vector< std::vector< double > >::size_type n, vdouble1d_t x)"},
-	 { "vdouble2d_t_resize", _wrap_vdouble2d_t_resize, METH_VARARGS, "\n"
-		"vdouble2d_t_resize(vdouble2d_t self, std::vector< std::vector< double > >::size_type new_size)\n"
-		"vdouble2d_t_resize(vdouble2d_t self, std::vector< std::vector< double > >::size_type new_size, vdouble1d_t x)\n"
+	 { "vdouble2d_T_push_back", _wrap_vdouble2d_T_push_back, METH_VARARGS, "vdouble2d_T_push_back(vdouble2d_T self, vdouble1d_T x)"},
+	 { "vdouble2d_T_front", _wrap_vdouble2d_T_front, METH_O, "vdouble2d_T_front(vdouble2d_T self) -> vdouble1d_T"},
+	 { "vdouble2d_T_back", _wrap_vdouble2d_T_back, METH_O, "vdouble2d_T_back(vdouble2d_T self) -> vdouble1d_T"},
+	 { "vdouble2d_T_assign", _wrap_vdouble2d_T_assign, METH_VARARGS, "vdouble2d_T_assign(vdouble2d_T self, std::vector< std::vector< double > >::size_type n, vdouble1d_T x)"},
+	 { "vdouble2d_T_resize", _wrap_vdouble2d_T_resize, METH_VARARGS, "\n"
+		"vdouble2d_T_resize(vdouble2d_T self, std::vector< std::vector< double > >::size_type new_size)\n"
+		"vdouble2d_T_resize(vdouble2d_T self, std::vector< std::vector< double > >::size_type new_size, vdouble1d_T x)\n"
 		""},
-	 { "vdouble2d_t_insert", _wrap_vdouble2d_t_insert, METH_VARARGS, "\n"
-		"vdouble2d_t_insert(vdouble2d_t self, std::vector< std::vector< double > >::iterator pos, vdouble1d_t x) -> std::vector< std::vector< double > >::iterator\n"
-		"vdouble2d_t_insert(vdouble2d_t self, std::vector< std::vector< double > >::iterator pos, std::vector< std::vector< double > >::size_type n, vdouble1d_t x)\n"
+	 { "vdouble2d_T_insert", _wrap_vdouble2d_T_insert, METH_VARARGS, "\n"
+		"vdouble2d_T_insert(vdouble2d_T self, std::vector< std::vector< double > >::iterator pos, vdouble1d_T x) -> std::vector< std::vector< double > >::iterator\n"
+		"vdouble2d_T_insert(vdouble2d_T self, std::vector< std::vector< double > >::iterator pos, std::vector< std::vector< double > >::size_type n, vdouble1d_T x)\n"
 		""},
-	 { "vdouble2d_t_reserve", _wrap_vdouble2d_t_reserve, METH_VARARGS, "vdouble2d_t_reserve(vdouble2d_t self, std::vector< std::vector< double > >::size_type n)"},
-	 { "vdouble2d_t_capacity", _wrap_vdouble2d_t_capacity, METH_O, "vdouble2d_t_capacity(vdouble2d_t self) -> std::vector< std::vector< double > >::size_type"},
-	 { "delete_vdouble2d_t", _wrap_delete_vdouble2d_t, METH_O, "delete_vdouble2d_t(vdouble2d_t self)"},
-	 { "vdouble2d_t_swigregister", vdouble2d_t_swigregister, METH_O, NULL},
-	 { "vdouble2d_t_swiginit", vdouble2d_t_swiginit, METH_VARARGS, NULL},
-	 { "vector_integer_t_iterator", _wrap_vector_integer_t_iterator, METH_O, "vector_integer_t_iterator(vector_integer_t self) -> SwigPyIterator"},
-	 { "vector_integer_t___nonzero__", _wrap_vector_integer_t___nonzero__, METH_O, "vector_integer_t___nonzero__(vector_integer_t self) -> bool"},
-	 { "vector_integer_t___bool__", _wrap_vector_integer_t___bool__, METH_O, "vector_integer_t___bool__(vector_integer_t self) -> bool"},
-	 { "vector_integer_t___len__", _wrap_vector_integer_t___len__, METH_O, "vector_integer_t___len__(vector_integer_t self) -> std::vector< int >::size_type"},
-	 { "vector_integer_t___getslice__", _wrap_vector_integer_t___getslice__, METH_VARARGS, "vector_integer_t___getslice__(vector_integer_t self, std::vector< int >::difference_type i, std::vector< int >::difference_type j) -> vector_integer_t"},
-	 { "vector_integer_t___setslice__", _wrap_vector_integer_t___setslice__, METH_VARARGS, "\n"
-		"vector_integer_t___setslice__(vector_integer_t self, std::vector< int >::difference_type i, std::vector< int >::difference_type j)\n"
-		"vector_integer_t___setslice__(vector_integer_t self, std::vector< int >::difference_type i, std::vector< int >::difference_type j, vector_integer_t v)\n"
+	 { "vdouble2d_T_reserve", _wrap_vdouble2d_T_reserve, METH_VARARGS, "vdouble2d_T_reserve(vdouble2d_T self, std::vector< std::vector< double > >::size_type n)"},
+	 { "vdouble2d_T_capacity", _wrap_vdouble2d_T_capacity, METH_O, "vdouble2d_T_capacity(vdouble2d_T self) -> std::vector< std::vector< double > >::size_type"},
+	 { "delete_vdouble2d_T", _wrap_delete_vdouble2d_T, METH_O, "delete_vdouble2d_T(vdouble2d_T self)"},
+	 { "vdouble2d_T_swigregister", vdouble2d_T_swigregister, METH_O, NULL},
+	 { "vdouble2d_T_swiginit", vdouble2d_T_swiginit, METH_VARARGS, NULL},
+	 { "vector_integer_T_iterator", _wrap_vector_integer_T_iterator, METH_O, "vector_integer_T_iterator(vector_integer_T self) -> SwigPyIterator"},
+	 { "vector_integer_T___nonzero__", _wrap_vector_integer_T___nonzero__, METH_O, "vector_integer_T___nonzero__(vector_integer_T self) -> bool"},
+	 { "vector_integer_T___bool__", _wrap_vector_integer_T___bool__, METH_O, "vector_integer_T___bool__(vector_integer_T self) -> bool"},
+	 { "vector_integer_T___len__", _wrap_vector_integer_T___len__, METH_O, "vector_integer_T___len__(vector_integer_T self) -> std::vector< int >::size_type"},
+	 { "vector_integer_T___getslice__", _wrap_vector_integer_T___getslice__, METH_VARARGS, "vector_integer_T___getslice__(vector_integer_T self, std::vector< int >::difference_type i, std::vector< int >::difference_type j) -> vector_integer_T"},
+	 { "vector_integer_T___setslice__", _wrap_vector_integer_T___setslice__, METH_VARARGS, "\n"
+		"vector_integer_T___setslice__(vector_integer_T self, std::vector< int >::difference_type i, std::vector< int >::difference_type j)\n"
+		"vector_integer_T___setslice__(vector_integer_T self, std::vector< int >::difference_type i, std::vector< int >::difference_type j, vector_integer_T v)\n"
 		""},
-	 { "vector_integer_t___delslice__", _wrap_vector_integer_t___delslice__, METH_VARARGS, "vector_integer_t___delslice__(vector_integer_t self, std::vector< int >::difference_type i, std::vector< int >::difference_type j)"},
-	 { "vector_integer_t___delitem__", _wrap_vector_integer_t___delitem__, METH_VARARGS, "\n"
-		"vector_integer_t___delitem__(vector_integer_t self, std::vector< int >::difference_type i)\n"
-		"vector_integer_t___delitem__(vector_integer_t self, SWIGPY_SLICEOBJECT * slice)\n"
+	 { "vector_integer_T___delslice__", _wrap_vector_integer_T___delslice__, METH_VARARGS, "vector_integer_T___delslice__(vector_integer_T self, std::vector< int >::difference_type i, std::vector< int >::difference_type j)"},
+	 { "vector_integer_T___delitem__", _wrap_vector_integer_T___delitem__, METH_VARARGS, "\n"
+		"vector_integer_T___delitem__(vector_integer_T self, std::vector< int >::difference_type i)\n"
+		"vector_integer_T___delitem__(vector_integer_T self, SWIGPY_SLICEOBJECT * slice)\n"
 		""},
-	 { "vector_integer_t___getitem__", _wrap_vector_integer_t___getitem__, METH_VARARGS, "\n"
-		"vector_integer_t___getitem__(vector_integer_t self, SWIGPY_SLICEOBJECT * slice) -> vector_integer_t\n"
-		"vector_integer_t___getitem__(vector_integer_t self, std::vector< int >::difference_type i) -> std::vector< int >::value_type const &\n"
+	 { "vector_integer_T___getitem__", _wrap_vector_integer_T___getitem__, METH_VARARGS, "\n"
+		"vector_integer_T___getitem__(vector_integer_T self, SWIGPY_SLICEOBJECT * slice) -> vector_integer_T\n"
+		"vector_integer_T___getitem__(vector_integer_T self, std::vector< int >::difference_type i) -> std::vector< int >::value_type const &\n"
 		""},
-	 { "vector_integer_t___setitem__", _wrap_vector_integer_t___setitem__, METH_VARARGS, "\n"
-		"vector_integer_t___setitem__(vector_integer_t self, SWIGPY_SLICEOBJECT * slice, vector_integer_t v)\n"
-		"vector_integer_t___setitem__(vector_integer_t self, SWIGPY_SLICEOBJECT * slice)\n"
-		"vector_integer_t___setitem__(vector_integer_t self, std::vector< int >::difference_type i, std::vector< int >::value_type const & x)\n"
+	 { "vector_integer_T___setitem__", _wrap_vector_integer_T___setitem__, METH_VARARGS, "\n"
+		"vector_integer_T___setitem__(vector_integer_T self, SWIGPY_SLICEOBJECT * slice, vector_integer_T v)\n"
+		"vector_integer_T___setitem__(vector_integer_T self, SWIGPY_SLICEOBJECT * slice)\n"
+		"vector_integer_T___setitem__(vector_integer_T self, std::vector< int >::difference_type i, std::vector< int >::value_type const & x)\n"
 		""},
-	 { "vector_integer_t_pop", _wrap_vector_integer_t_pop, METH_O, "vector_integer_t_pop(vector_integer_t self) -> std::vector< int >::value_type"},
-	 { "vector_integer_t_append", _wrap_vector_integer_t_append, METH_VARARGS, "vector_integer_t_append(vector_integer_t self, std::vector< int >::value_type const & x)"},
-	 { "vector_integer_t_empty", _wrap_vector_integer_t_empty, METH_O, "vector_integer_t_empty(vector_integer_t self) -> bool"},
-	 { "vector_integer_t_size", _wrap_vector_integer_t_size, METH_O, "vector_integer_t_size(vector_integer_t self) -> std::vector< int >::size_type"},
-	 { "vector_integer_t_swap", _wrap_vector_integer_t_swap, METH_VARARGS, "vector_integer_t_swap(vector_integer_t self, vector_integer_t v)"},
-	 { "vector_integer_t_begin", _wrap_vector_integer_t_begin, METH_O, "vector_integer_t_begin(vector_integer_t self) -> std::vector< int >::iterator"},
-	 { "vector_integer_t_end", _wrap_vector_integer_t_end, METH_O, "vector_integer_t_end(vector_integer_t self) -> std::vector< int >::iterator"},
-	 { "vector_integer_t_rbegin", _wrap_vector_integer_t_rbegin, METH_O, "vector_integer_t_rbegin(vector_integer_t self) -> std::vector< int >::reverse_iterator"},
-	 { "vector_integer_t_rend", _wrap_vector_integer_t_rend, METH_O, "vector_integer_t_rend(vector_integer_t self) -> std::vector< int >::reverse_iterator"},
-	 { "vector_integer_t_clear", _wrap_vector_integer_t_clear, METH_O, "vector_integer_t_clear(vector_integer_t self)"},
-	 { "vector_integer_t_get_allocator", _wrap_vector_integer_t_get_allocator, METH_O, "vector_integer_t_get_allocator(vector_integer_t self) -> std::vector< int >::allocator_type"},
-	 { "vector_integer_t_pop_back", _wrap_vector_integer_t_pop_back, METH_O, "vector_integer_t_pop_back(vector_integer_t self)"},
-	 { "vector_integer_t_erase", _wrap_vector_integer_t_erase, METH_VARARGS, "\n"
-		"vector_integer_t_erase(vector_integer_t self, std::vector< int >::iterator pos) -> std::vector< int >::iterator\n"
-		"vector_integer_t_erase(vector_integer_t self, std::vector< int >::iterator first, std::vector< int >::iterator last) -> std::vector< int >::iterator\n"
+	 { "vector_integer_T_pop", _wrap_vector_integer_T_pop, METH_O, "vector_integer_T_pop(vector_integer_T self) -> std::vector< int >::value_type"},
+	 { "vector_integer_T_append", _wrap_vector_integer_T_append, METH_VARARGS, "vector_integer_T_append(vector_integer_T self, std::vector< int >::value_type const & x)"},
+	 { "vector_integer_T_empty", _wrap_vector_integer_T_empty, METH_O, "vector_integer_T_empty(vector_integer_T self) -> bool"},
+	 { "vector_integer_T_size", _wrap_vector_integer_T_size, METH_O, "vector_integer_T_size(vector_integer_T self) -> std::vector< int >::size_type"},
+	 { "vector_integer_T_swap", _wrap_vector_integer_T_swap, METH_VARARGS, "vector_integer_T_swap(vector_integer_T self, vector_integer_T v)"},
+	 { "vector_integer_T_begin", _wrap_vector_integer_T_begin, METH_O, "vector_integer_T_begin(vector_integer_T self) -> std::vector< int >::iterator"},
+	 { "vector_integer_T_end", _wrap_vector_integer_T_end, METH_O, "vector_integer_T_end(vector_integer_T self) -> std::vector< int >::iterator"},
+	 { "vector_integer_T_rbegin", _wrap_vector_integer_T_rbegin, METH_O, "vector_integer_T_rbegin(vector_integer_T self) -> std::vector< int >::reverse_iterator"},
+	 { "vector_integer_T_rend", _wrap_vector_integer_T_rend, METH_O, "vector_integer_T_rend(vector_integer_T self) -> std::vector< int >::reverse_iterator"},
+	 { "vector_integer_T_clear", _wrap_vector_integer_T_clear, METH_O, "vector_integer_T_clear(vector_integer_T self)"},
+	 { "vector_integer_T_get_allocator", _wrap_vector_integer_T_get_allocator, METH_O, "vector_integer_T_get_allocator(vector_integer_T self) -> std::vector< int >::allocator_type"},
+	 { "vector_integer_T_pop_back", _wrap_vector_integer_T_pop_back, METH_O, "vector_integer_T_pop_back(vector_integer_T self)"},
+	 { "vector_integer_T_erase", _wrap_vector_integer_T_erase, METH_VARARGS, "\n"
+		"vector_integer_T_erase(vector_integer_T self, std::vector< int >::iterator pos) -> std::vector< int >::iterator\n"
+		"vector_integer_T_erase(vector_integer_T self, std::vector< int >::iterator first, std::vector< int >::iterator last) -> std::vector< int >::iterator\n"
 		""},
-	 { "new_vector_integer_t", _wrap_new_vector_integer_t, METH_VARARGS, "\n"
-		"vector_integer_t()\n"
-		"vector_integer_t(vector_integer_t other)\n"
-		"vector_integer_t(std::vector< int >::size_type size)\n"
-		"new_vector_integer_t(std::vector< int >::size_type size, std::vector< int >::value_type const & value) -> vector_integer_t\n"
+	 { "new_vector_integer_T", _wrap_new_vector_integer_T, METH_VARARGS, "\n"
+		"vector_integer_T()\n"
+		"vector_integer_T(vector_integer_T other)\n"
+		"vector_integer_T(std::vector< int >::size_type size)\n"
+		"new_vector_integer_T(std::vector< int >::size_type size, std::vector< int >::value_type const & value) -> vector_integer_T\n"
 		""},
-	 { "vector_integer_t_push_back", _wrap_vector_integer_t_push_back, METH_VARARGS, "vector_integer_t_push_back(vector_integer_t self, std::vector< int >::value_type const & x)"},
-	 { "vector_integer_t_front", _wrap_vector_integer_t_front, METH_O, "vector_integer_t_front(vector_integer_t self) -> std::vector< int >::value_type const &"},
-	 { "vector_integer_t_back", _wrap_vector_integer_t_back, METH_O, "vector_integer_t_back(vector_integer_t self) -> std::vector< int >::value_type const &"},
-	 { "vector_integer_t_assign", _wrap_vector_integer_t_assign, METH_VARARGS, "vector_integer_t_assign(vector_integer_t self, std::vector< int >::size_type n, std::vector< int >::value_type const & x)"},
-	 { "vector_integer_t_resize", _wrap_vector_integer_t_resize, METH_VARARGS, "\n"
-		"vector_integer_t_resize(vector_integer_t self, std::vector< int >::size_type new_size)\n"
-		"vector_integer_t_resize(vector_integer_t self, std::vector< int >::size_type new_size, std::vector< int >::value_type const & x)\n"
+	 { "vector_integer_T_push_back", _wrap_vector_integer_T_push_back, METH_VARARGS, "vector_integer_T_push_back(vector_integer_T self, std::vector< int >::value_type const & x)"},
+	 { "vector_integer_T_front", _wrap_vector_integer_T_front, METH_O, "vector_integer_T_front(vector_integer_T self) -> std::vector< int >::value_type const &"},
+	 { "vector_integer_T_back", _wrap_vector_integer_T_back, METH_O, "vector_integer_T_back(vector_integer_T self) -> std::vector< int >::value_type const &"},
+	 { "vector_integer_T_assign", _wrap_vector_integer_T_assign, METH_VARARGS, "vector_integer_T_assign(vector_integer_T self, std::vector< int >::size_type n, std::vector< int >::value_type const & x)"},
+	 { "vector_integer_T_resize", _wrap_vector_integer_T_resize, METH_VARARGS, "\n"
+		"vector_integer_T_resize(vector_integer_T self, std::vector< int >::size_type new_size)\n"
+		"vector_integer_T_resize(vector_integer_T self, std::vector< int >::size_type new_size, std::vector< int >::value_type const & x)\n"
 		""},
-	 { "vector_integer_t_insert", _wrap_vector_integer_t_insert, METH_VARARGS, "\n"
-		"vector_integer_t_insert(vector_integer_t self, std::vector< int >::iterator pos, std::vector< int >::value_type const & x) -> std::vector< int >::iterator\n"
-		"vector_integer_t_insert(vector_integer_t self, std::vector< int >::iterator pos, std::vector< int >::size_type n, std::vector< int >::value_type const & x)\n"
+	 { "vector_integer_T_insert", _wrap_vector_integer_T_insert, METH_VARARGS, "\n"
+		"vector_integer_T_insert(vector_integer_T self, std::vector< int >::iterator pos, std::vector< int >::value_type const & x) -> std::vector< int >::iterator\n"
+		"vector_integer_T_insert(vector_integer_T self, std::vector< int >::iterator pos, std::vector< int >::size_type n, std::vector< int >::value_type const & x)\n"
 		""},
-	 { "vector_integer_t_reserve", _wrap_vector_integer_t_reserve, METH_VARARGS, "vector_integer_t_reserve(vector_integer_t self, std::vector< int >::size_type n)"},
-	 { "vector_integer_t_capacity", _wrap_vector_integer_t_capacity, METH_O, "vector_integer_t_capacity(vector_integer_t self) -> std::vector< int >::size_type"},
-	 { "delete_vector_integer_t", _wrap_delete_vector_integer_t, METH_O, "delete_vector_integer_t(vector_integer_t self)"},
-	 { "vector_integer_t_swigregister", vector_integer_t_swigregister, METH_O, NULL},
-	 { "vector_integer_t_swiginit", vector_integer_t_swiginit, METH_VARARGS, NULL},
-	 { "vinteger2d_t_iterator", _wrap_vinteger2d_t_iterator, METH_O, "vinteger2d_t_iterator(vinteger2d_t self) -> SwigPyIterator"},
-	 { "vinteger2d_t___nonzero__", _wrap_vinteger2d_t___nonzero__, METH_O, "vinteger2d_t___nonzero__(vinteger2d_t self) -> bool"},
-	 { "vinteger2d_t___bool__", _wrap_vinteger2d_t___bool__, METH_O, "vinteger2d_t___bool__(vinteger2d_t self) -> bool"},
-	 { "vinteger2d_t___len__", _wrap_vinteger2d_t___len__, METH_O, "vinteger2d_t___len__(vinteger2d_t self) -> std::vector< std::vector< int > >::size_type"},
-	 { "vinteger2d_t___getslice__", _wrap_vinteger2d_t___getslice__, METH_VARARGS, "vinteger2d_t___getslice__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j) -> vinteger2d_t"},
-	 { "vinteger2d_t___setslice__", _wrap_vinteger2d_t___setslice__, METH_VARARGS, "\n"
-		"vinteger2d_t___setslice__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j)\n"
-		"vinteger2d_t___setslice__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j, vinteger2d_t v)\n"
+	 { "vector_integer_T_reserve", _wrap_vector_integer_T_reserve, METH_VARARGS, "vector_integer_T_reserve(vector_integer_T self, std::vector< int >::size_type n)"},
+	 { "vector_integer_T_capacity", _wrap_vector_integer_T_capacity, METH_O, "vector_integer_T_capacity(vector_integer_T self) -> std::vector< int >::size_type"},
+	 { "delete_vector_integer_T", _wrap_delete_vector_integer_T, METH_O, "delete_vector_integer_T(vector_integer_T self)"},
+	 { "vector_integer_T_swigregister", vector_integer_T_swigregister, METH_O, NULL},
+	 { "vector_integer_T_swiginit", vector_integer_T_swiginit, METH_VARARGS, NULL},
+	 { "vinteger2d_T_iterator", _wrap_vinteger2d_T_iterator, METH_O, "vinteger2d_T_iterator(vinteger2d_T self) -> SwigPyIterator"},
+	 { "vinteger2d_T___nonzero__", _wrap_vinteger2d_T___nonzero__, METH_O, "vinteger2d_T___nonzero__(vinteger2d_T self) -> bool"},
+	 { "vinteger2d_T___bool__", _wrap_vinteger2d_T___bool__, METH_O, "vinteger2d_T___bool__(vinteger2d_T self) -> bool"},
+	 { "vinteger2d_T___len__", _wrap_vinteger2d_T___len__, METH_O, "vinteger2d_T___len__(vinteger2d_T self) -> std::vector< std::vector< int > >::size_type"},
+	 { "vinteger2d_T___getslice__", _wrap_vinteger2d_T___getslice__, METH_VARARGS, "vinteger2d_T___getslice__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j) -> vinteger2d_T"},
+	 { "vinteger2d_T___setslice__", _wrap_vinteger2d_T___setslice__, METH_VARARGS, "\n"
+		"vinteger2d_T___setslice__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j)\n"
+		"vinteger2d_T___setslice__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j, vinteger2d_T v)\n"
 		""},
-	 { "vinteger2d_t___delslice__", _wrap_vinteger2d_t___delslice__, METH_VARARGS, "vinteger2d_t___delslice__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j)"},
-	 { "vinteger2d_t___delitem__", _wrap_vinteger2d_t___delitem__, METH_VARARGS, "\n"
-		"vinteger2d_t___delitem__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i)\n"
-		"vinteger2d_t___delitem__(vinteger2d_t self, SWIGPY_SLICEOBJECT * slice)\n"
+	 { "vinteger2d_T___delslice__", _wrap_vinteger2d_T___delslice__, METH_VARARGS, "vinteger2d_T___delslice__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j)"},
+	 { "vinteger2d_T___delitem__", _wrap_vinteger2d_T___delitem__, METH_VARARGS, "\n"
+		"vinteger2d_T___delitem__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i)\n"
+		"vinteger2d_T___delitem__(vinteger2d_T self, SWIGPY_SLICEOBJECT * slice)\n"
 		""},
-	 { "vinteger2d_t___getitem__", _wrap_vinteger2d_t___getitem__, METH_VARARGS, "\n"
-		"vinteger2d_t___getitem__(vinteger2d_t self, SWIGPY_SLICEOBJECT * slice) -> vinteger2d_t\n"
-		"vinteger2d_t___getitem__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i) -> vector_integer_t\n"
+	 { "vinteger2d_T___getitem__", _wrap_vinteger2d_T___getitem__, METH_VARARGS, "\n"
+		"vinteger2d_T___getitem__(vinteger2d_T self, SWIGPY_SLICEOBJECT * slice) -> vinteger2d_T\n"
+		"vinteger2d_T___getitem__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i) -> vector_integer_T\n"
 		""},
-	 { "vinteger2d_t___setitem__", _wrap_vinteger2d_t___setitem__, METH_VARARGS, "\n"
-		"vinteger2d_t___setitem__(vinteger2d_t self, SWIGPY_SLICEOBJECT * slice, vinteger2d_t v)\n"
-		"vinteger2d_t___setitem__(vinteger2d_t self, SWIGPY_SLICEOBJECT * slice)\n"
-		"vinteger2d_t___setitem__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i, vector_integer_t x)\n"
+	 { "vinteger2d_T___setitem__", _wrap_vinteger2d_T___setitem__, METH_VARARGS, "\n"
+		"vinteger2d_T___setitem__(vinteger2d_T self, SWIGPY_SLICEOBJECT * slice, vinteger2d_T v)\n"
+		"vinteger2d_T___setitem__(vinteger2d_T self, SWIGPY_SLICEOBJECT * slice)\n"
+		"vinteger2d_T___setitem__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i, vector_integer_T x)\n"
 		""},
-	 { "vinteger2d_t_pop", _wrap_vinteger2d_t_pop, METH_O, "vinteger2d_t_pop(vinteger2d_t self) -> vector_integer_t"},
-	 { "vinteger2d_t_append", _wrap_vinteger2d_t_append, METH_VARARGS, "vinteger2d_t_append(vinteger2d_t self, vector_integer_t x)"},
-	 { "vinteger2d_t_empty", _wrap_vinteger2d_t_empty, METH_O, "vinteger2d_t_empty(vinteger2d_t self) -> bool"},
-	 { "vinteger2d_t_size", _wrap_vinteger2d_t_size, METH_O, "vinteger2d_t_size(vinteger2d_t self) -> std::vector< std::vector< int > >::size_type"},
-	 { "vinteger2d_t_swap", _wrap_vinteger2d_t_swap, METH_VARARGS, "vinteger2d_t_swap(vinteger2d_t self, vinteger2d_t v)"},
-	 { "vinteger2d_t_begin", _wrap_vinteger2d_t_begin, METH_O, "vinteger2d_t_begin(vinteger2d_t self) -> std::vector< std::vector< int > >::iterator"},
-	 { "vinteger2d_t_end", _wrap_vinteger2d_t_end, METH_O, "vinteger2d_t_end(vinteger2d_t self) -> std::vector< std::vector< int > >::iterator"},
-	 { "vinteger2d_t_rbegin", _wrap_vinteger2d_t_rbegin, METH_O, "vinteger2d_t_rbegin(vinteger2d_t self) -> std::vector< std::vector< int > >::reverse_iterator"},
-	 { "vinteger2d_t_rend", _wrap_vinteger2d_t_rend, METH_O, "vinteger2d_t_rend(vinteger2d_t self) -> std::vector< std::vector< int > >::reverse_iterator"},
-	 { "vinteger2d_t_clear", _wrap_vinteger2d_t_clear, METH_O, "vinteger2d_t_clear(vinteger2d_t self)"},
-	 { "vinteger2d_t_get_allocator", _wrap_vinteger2d_t_get_allocator, METH_O, "vinteger2d_t_get_allocator(vinteger2d_t self) -> std::vector< std::vector< int > >::allocator_type"},
-	 { "vinteger2d_t_pop_back", _wrap_vinteger2d_t_pop_back, METH_O, "vinteger2d_t_pop_back(vinteger2d_t self)"},
-	 { "vinteger2d_t_erase", _wrap_vinteger2d_t_erase, METH_VARARGS, "\n"
-		"vinteger2d_t_erase(vinteger2d_t self, std::vector< std::vector< int > >::iterator pos) -> std::vector< std::vector< int > >::iterator\n"
-		"vinteger2d_t_erase(vinteger2d_t self, std::vector< std::vector< int > >::iterator first, std::vector< std::vector< int > >::iterator last) -> std::vector< std::vector< int > >::iterator\n"
+	 { "vinteger2d_T_pop", _wrap_vinteger2d_T_pop, METH_O, "vinteger2d_T_pop(vinteger2d_T self) -> vector_integer_T"},
+	 { "vinteger2d_T_append", _wrap_vinteger2d_T_append, METH_VARARGS, "vinteger2d_T_append(vinteger2d_T self, vector_integer_T x)"},
+	 { "vinteger2d_T_empty", _wrap_vinteger2d_T_empty, METH_O, "vinteger2d_T_empty(vinteger2d_T self) -> bool"},
+	 { "vinteger2d_T_size", _wrap_vinteger2d_T_size, METH_O, "vinteger2d_T_size(vinteger2d_T self) -> std::vector< std::vector< int > >::size_type"},
+	 { "vinteger2d_T_swap", _wrap_vinteger2d_T_swap, METH_VARARGS, "vinteger2d_T_swap(vinteger2d_T self, vinteger2d_T v)"},
+	 { "vinteger2d_T_begin", _wrap_vinteger2d_T_begin, METH_O, "vinteger2d_T_begin(vinteger2d_T self) -> std::vector< std::vector< int > >::iterator"},
+	 { "vinteger2d_T_end", _wrap_vinteger2d_T_end, METH_O, "vinteger2d_T_end(vinteger2d_T self) -> std::vector< std::vector< int > >::iterator"},
+	 { "vinteger2d_T_rbegin", _wrap_vinteger2d_T_rbegin, METH_O, "vinteger2d_T_rbegin(vinteger2d_T self) -> std::vector< std::vector< int > >::reverse_iterator"},
+	 { "vinteger2d_T_rend", _wrap_vinteger2d_T_rend, METH_O, "vinteger2d_T_rend(vinteger2d_T self) -> std::vector< std::vector< int > >::reverse_iterator"},
+	 { "vinteger2d_T_clear", _wrap_vinteger2d_T_clear, METH_O, "vinteger2d_T_clear(vinteger2d_T self)"},
+	 { "vinteger2d_T_get_allocator", _wrap_vinteger2d_T_get_allocator, METH_O, "vinteger2d_T_get_allocator(vinteger2d_T self) -> std::vector< std::vector< int > >::allocator_type"},
+	 { "vinteger2d_T_pop_back", _wrap_vinteger2d_T_pop_back, METH_O, "vinteger2d_T_pop_back(vinteger2d_T self)"},
+	 { "vinteger2d_T_erase", _wrap_vinteger2d_T_erase, METH_VARARGS, "\n"
+		"vinteger2d_T_erase(vinteger2d_T self, std::vector< std::vector< int > >::iterator pos) -> std::vector< std::vector< int > >::iterator\n"
+		"vinteger2d_T_erase(vinteger2d_T self, std::vector< std::vector< int > >::iterator first, std::vector< std::vector< int > >::iterator last) -> std::vector< std::vector< int > >::iterator\n"
 		""},
-	 { "new_vinteger2d_t", _wrap_new_vinteger2d_t, METH_VARARGS, "\n"
-		"vinteger2d_t()\n"
-		"vinteger2d_t(vinteger2d_t other)\n"
-		"vinteger2d_t(std::vector< std::vector< int > >::size_type size)\n"
-		"new_vinteger2d_t(std::vector< std::vector< int > >::size_type size, vector_integer_t value) -> vinteger2d_t\n"
+	 { "new_vinteger2d_T", _wrap_new_vinteger2d_T, METH_VARARGS, "\n"
+		"vinteger2d_T()\n"
+		"vinteger2d_T(vinteger2d_T other)\n"
+		"vinteger2d_T(std::vector< std::vector< int > >::size_type size)\n"
+		"new_vinteger2d_T(std::vector< std::vector< int > >::size_type size, vector_integer_T value) -> vinteger2d_T\n"
 		""},
-	 { "vinteger2d_t_push_back", _wrap_vinteger2d_t_push_back, METH_VARARGS, "vinteger2d_t_push_back(vinteger2d_t self, vector_integer_t x)"},
-	 { "vinteger2d_t_front", _wrap_vinteger2d_t_front, METH_O, "vinteger2d_t_front(vinteger2d_t self) -> vector_integer_t"},
-	 { "vinteger2d_t_back", _wrap_vinteger2d_t_back, METH_O, "vinteger2d_t_back(vinteger2d_t self) -> vector_integer_t"},
-	 { "vinteger2d_t_assign", _wrap_vinteger2d_t_assign, METH_VARARGS, "vinteger2d_t_assign(vinteger2d_t self, std::vector< std::vector< int > >::size_type n, vector_integer_t x)"},
-	 { "vinteger2d_t_resize", _wrap_vinteger2d_t_resize, METH_VARARGS, "\n"
-		"vinteger2d_t_resize(vinteger2d_t self, std::vector< std::vector< int > >::size_type new_size)\n"
-		"vinteger2d_t_resize(vinteger2d_t self, std::vector< std::vector< int > >::size_type new_size, vector_integer_t x)\n"
+	 { "vinteger2d_T_push_back", _wrap_vinteger2d_T_push_back, METH_VARARGS, "vinteger2d_T_push_back(vinteger2d_T self, vector_integer_T x)"},
+	 { "vinteger2d_T_front", _wrap_vinteger2d_T_front, METH_O, "vinteger2d_T_front(vinteger2d_T self) -> vector_integer_T"},
+	 { "vinteger2d_T_back", _wrap_vinteger2d_T_back, METH_O, "vinteger2d_T_back(vinteger2d_T self) -> vector_integer_T"},
+	 { "vinteger2d_T_assign", _wrap_vinteger2d_T_assign, METH_VARARGS, "vinteger2d_T_assign(vinteger2d_T self, std::vector< std::vector< int > >::size_type n, vector_integer_T x)"},
+	 { "vinteger2d_T_resize", _wrap_vinteger2d_T_resize, METH_VARARGS, "\n"
+		"vinteger2d_T_resize(vinteger2d_T self, std::vector< std::vector< int > >::size_type new_size)\n"
+		"vinteger2d_T_resize(vinteger2d_T self, std::vector< std::vector< int > >::size_type new_size, vector_integer_T x)\n"
 		""},
-	 { "vinteger2d_t_insert", _wrap_vinteger2d_t_insert, METH_VARARGS, "\n"
-		"vinteger2d_t_insert(vinteger2d_t self, std::vector< std::vector< int > >::iterator pos, vector_integer_t x) -> std::vector< std::vector< int > >::iterator\n"
-		"vinteger2d_t_insert(vinteger2d_t self, std::vector< std::vector< int > >::iterator pos, std::vector< std::vector< int > >::size_type n, vector_integer_t x)\n"
+	 { "vinteger2d_T_insert", _wrap_vinteger2d_T_insert, METH_VARARGS, "\n"
+		"vinteger2d_T_insert(vinteger2d_T self, std::vector< std::vector< int > >::iterator pos, vector_integer_T x) -> std::vector< std::vector< int > >::iterator\n"
+		"vinteger2d_T_insert(vinteger2d_T self, std::vector< std::vector< int > >::iterator pos, std::vector< std::vector< int > >::size_type n, vector_integer_T x)\n"
 		""},
-	 { "vinteger2d_t_reserve", _wrap_vinteger2d_t_reserve, METH_VARARGS, "vinteger2d_t_reserve(vinteger2d_t self, std::vector< std::vector< int > >::size_type n)"},
-	 { "vinteger2d_t_capacity", _wrap_vinteger2d_t_capacity, METH_O, "vinteger2d_t_capacity(vinteger2d_t self) -> std::vector< std::vector< int > >::size_type"},
-	 { "delete_vinteger2d_t", _wrap_delete_vinteger2d_t, METH_O, "delete_vinteger2d_t(vinteger2d_t self)"},
-	 { "vinteger2d_t_swigregister", vinteger2d_t_swigregister, METH_O, NULL},
-	 { "vinteger2d_t_swiginit", vinteger2d_t_swiginit, METH_VARARGS, NULL},
-	 { "vector_longinteger_t_iterator", _wrap_vector_longinteger_t_iterator, METH_O, "vector_longinteger_t_iterator(vector_longinteger_t self) -> SwigPyIterator"},
-	 { "vector_longinteger_t___nonzero__", _wrap_vector_longinteger_t___nonzero__, METH_O, "vector_longinteger_t___nonzero__(vector_longinteger_t self) -> bool"},
-	 { "vector_longinteger_t___bool__", _wrap_vector_longinteger_t___bool__, METH_O, "vector_longinteger_t___bool__(vector_longinteger_t self) -> bool"},
-	 { "vector_longinteger_t___len__", _wrap_vector_longinteger_t___len__, METH_O, "vector_longinteger_t___len__(vector_longinteger_t self) -> std::vector< unsigned long >::size_type"},
-	 { "vector_longinteger_t___getslice__", _wrap_vector_longinteger_t___getslice__, METH_VARARGS, "vector_longinteger_t___getslice__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j) -> vector_longinteger_t"},
-	 { "vector_longinteger_t___setslice__", _wrap_vector_longinteger_t___setslice__, METH_VARARGS, "\n"
-		"vector_longinteger_t___setslice__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j)\n"
-		"vector_longinteger_t___setslice__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j, vector_longinteger_t v)\n"
+	 { "vinteger2d_T_reserve", _wrap_vinteger2d_T_reserve, METH_VARARGS, "vinteger2d_T_reserve(vinteger2d_T self, std::vector< std::vector< int > >::size_type n)"},
+	 { "vinteger2d_T_capacity", _wrap_vinteger2d_T_capacity, METH_O, "vinteger2d_T_capacity(vinteger2d_T self) -> std::vector< std::vector< int > >::size_type"},
+	 { "delete_vinteger2d_T", _wrap_delete_vinteger2d_T, METH_O, "delete_vinteger2d_T(vinteger2d_T self)"},
+	 { "vinteger2d_T_swigregister", vinteger2d_T_swigregister, METH_O, NULL},
+	 { "vinteger2d_T_swiginit", vinteger2d_T_swiginit, METH_VARARGS, NULL},
+	 { "vector_longinteger_T_iterator", _wrap_vector_longinteger_T_iterator, METH_O, "vector_longinteger_T_iterator(vector_longinteger_T self) -> SwigPyIterator"},
+	 { "vector_longinteger_T___nonzero__", _wrap_vector_longinteger_T___nonzero__, METH_O, "vector_longinteger_T___nonzero__(vector_longinteger_T self) -> bool"},
+	 { "vector_longinteger_T___bool__", _wrap_vector_longinteger_T___bool__, METH_O, "vector_longinteger_T___bool__(vector_longinteger_T self) -> bool"},
+	 { "vector_longinteger_T___len__", _wrap_vector_longinteger_T___len__, METH_O, "vector_longinteger_T___len__(vector_longinteger_T self) -> std::vector< unsigned long >::size_type"},
+	 { "vector_longinteger_T___getslice__", _wrap_vector_longinteger_T___getslice__, METH_VARARGS, "vector_longinteger_T___getslice__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j) -> vector_longinteger_T"},
+	 { "vector_longinteger_T___setslice__", _wrap_vector_longinteger_T___setslice__, METH_VARARGS, "\n"
+		"vector_longinteger_T___setslice__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j)\n"
+		"vector_longinteger_T___setslice__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j, vector_longinteger_T v)\n"
 		""},
-	 { "vector_longinteger_t___delslice__", _wrap_vector_longinteger_t___delslice__, METH_VARARGS, "vector_longinteger_t___delslice__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j)"},
-	 { "vector_longinteger_t___delitem__", _wrap_vector_longinteger_t___delitem__, METH_VARARGS, "\n"
-		"vector_longinteger_t___delitem__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i)\n"
-		"vector_longinteger_t___delitem__(vector_longinteger_t self, SWIGPY_SLICEOBJECT * slice)\n"
+	 { "vector_longinteger_T___delslice__", _wrap_vector_longinteger_T___delslice__, METH_VARARGS, "vector_longinteger_T___delslice__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j)"},
+	 { "vector_longinteger_T___delitem__", _wrap_vector_longinteger_T___delitem__, METH_VARARGS, "\n"
+		"vector_longinteger_T___delitem__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i)\n"
+		"vector_longinteger_T___delitem__(vector_longinteger_T self, SWIGPY_SLICEOBJECT * slice)\n"
 		""},
-	 { "vector_longinteger_t___getitem__", _wrap_vector_longinteger_t___getitem__, METH_VARARGS, "\n"
-		"vector_longinteger_t___getitem__(vector_longinteger_t self, SWIGPY_SLICEOBJECT * slice) -> vector_longinteger_t\n"
-		"vector_longinteger_t___getitem__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i) -> std::vector< unsigned long >::value_type const &\n"
+	 { "vector_longinteger_T___getitem__", _wrap_vector_longinteger_T___getitem__, METH_VARARGS, "\n"
+		"vector_longinteger_T___getitem__(vector_longinteger_T self, SWIGPY_SLICEOBJECT * slice) -> vector_longinteger_T\n"
+		"vector_longinteger_T___getitem__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i) -> std::vector< unsigned long >::value_type const &\n"
 		""},
-	 { "vector_longinteger_t___setitem__", _wrap_vector_longinteger_t___setitem__, METH_VARARGS, "\n"
-		"vector_longinteger_t___setitem__(vector_longinteger_t self, SWIGPY_SLICEOBJECT * slice, vector_longinteger_t v)\n"
-		"vector_longinteger_t___setitem__(vector_longinteger_t self, SWIGPY_SLICEOBJECT * slice)\n"
-		"vector_longinteger_t___setitem__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::value_type const & x)\n"
+	 { "vector_longinteger_T___setitem__", _wrap_vector_longinteger_T___setitem__, METH_VARARGS, "\n"
+		"vector_longinteger_T___setitem__(vector_longinteger_T self, SWIGPY_SLICEOBJECT * slice, vector_longinteger_T v)\n"
+		"vector_longinteger_T___setitem__(vector_longinteger_T self, SWIGPY_SLICEOBJECT * slice)\n"
+		"vector_longinteger_T___setitem__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::value_type const & x)\n"
 		""},
-	 { "vector_longinteger_t_pop", _wrap_vector_longinteger_t_pop, METH_O, "vector_longinteger_t_pop(vector_longinteger_t self) -> std::vector< unsigned long >::value_type"},
-	 { "vector_longinteger_t_append", _wrap_vector_longinteger_t_append, METH_VARARGS, "vector_longinteger_t_append(vector_longinteger_t self, std::vector< unsigned long >::value_type const & x)"},
-	 { "vector_longinteger_t_empty", _wrap_vector_longinteger_t_empty, METH_O, "vector_longinteger_t_empty(vector_longinteger_t self) -> bool"},
-	 { "vector_longinteger_t_size", _wrap_vector_longinteger_t_size, METH_O, "vector_longinteger_t_size(vector_longinteger_t self) -> std::vector< unsigned long >::size_type"},
-	 { "vector_longinteger_t_swap", _wrap_vector_longinteger_t_swap, METH_VARARGS, "vector_longinteger_t_swap(vector_longinteger_t self, vector_longinteger_t v)"},
-	 { "vector_longinteger_t_begin", _wrap_vector_longinteger_t_begin, METH_O, "vector_longinteger_t_begin(vector_longinteger_t self) -> std::vector< unsigned long >::iterator"},
-	 { "vector_longinteger_t_end", _wrap_vector_longinteger_t_end, METH_O, "vector_longinteger_t_end(vector_longinteger_t self) -> std::vector< unsigned long >::iterator"},
-	 { "vector_longinteger_t_rbegin", _wrap_vector_longinteger_t_rbegin, METH_O, "vector_longinteger_t_rbegin(vector_longinteger_t self) -> std::vector< unsigned long >::reverse_iterator"},
-	 { "vector_longinteger_t_rend", _wrap_vector_longinteger_t_rend, METH_O, "vector_longinteger_t_rend(vector_longinteger_t self) -> std::vector< unsigned long >::reverse_iterator"},
-	 { "vector_longinteger_t_clear", _wrap_vector_longinteger_t_clear, METH_O, "vector_longinteger_t_clear(vector_longinteger_t self)"},
-	 { "vector_longinteger_t_get_allocator", _wrap_vector_longinteger_t_get_allocator, METH_O, "vector_longinteger_t_get_allocator(vector_longinteger_t self) -> std::vector< unsigned long >::allocator_type"},
-	 { "vector_longinteger_t_pop_back", _wrap_vector_longinteger_t_pop_back, METH_O, "vector_longinteger_t_pop_back(vector_longinteger_t self)"},
-	 { "vector_longinteger_t_erase", _wrap_vector_longinteger_t_erase, METH_VARARGS, "\n"
-		"vector_longinteger_t_erase(vector_longinteger_t self, std::vector< unsigned long >::iterator pos) -> std::vector< unsigned long >::iterator\n"
-		"vector_longinteger_t_erase(vector_longinteger_t self, std::vector< unsigned long >::iterator first, std::vector< unsigned long >::iterator last) -> std::vector< unsigned long >::iterator\n"
+	 { "vector_longinteger_T_pop", _wrap_vector_longinteger_T_pop, METH_O, "vector_longinteger_T_pop(vector_longinteger_T self) -> std::vector< unsigned long >::value_type"},
+	 { "vector_longinteger_T_append", _wrap_vector_longinteger_T_append, METH_VARARGS, "vector_longinteger_T_append(vector_longinteger_T self, std::vector< unsigned long >::value_type const & x)"},
+	 { "vector_longinteger_T_empty", _wrap_vector_longinteger_T_empty, METH_O, "vector_longinteger_T_empty(vector_longinteger_T self) -> bool"},
+	 { "vector_longinteger_T_size", _wrap_vector_longinteger_T_size, METH_O, "vector_longinteger_T_size(vector_longinteger_T self) -> std::vector< unsigned long >::size_type"},
+	 { "vector_longinteger_T_swap", _wrap_vector_longinteger_T_swap, METH_VARARGS, "vector_longinteger_T_swap(vector_longinteger_T self, vector_longinteger_T v)"},
+	 { "vector_longinteger_T_begin", _wrap_vector_longinteger_T_begin, METH_O, "vector_longinteger_T_begin(vector_longinteger_T self) -> std::vector< unsigned long >::iterator"},
+	 { "vector_longinteger_T_end", _wrap_vector_longinteger_T_end, METH_O, "vector_longinteger_T_end(vector_longinteger_T self) -> std::vector< unsigned long >::iterator"},
+	 { "vector_longinteger_T_rbegin", _wrap_vector_longinteger_T_rbegin, METH_O, "vector_longinteger_T_rbegin(vector_longinteger_T self) -> std::vector< unsigned long >::reverse_iterator"},
+	 { "vector_longinteger_T_rend", _wrap_vector_longinteger_T_rend, METH_O, "vector_longinteger_T_rend(vector_longinteger_T self) -> std::vector< unsigned long >::reverse_iterator"},
+	 { "vector_longinteger_T_clear", _wrap_vector_longinteger_T_clear, METH_O, "vector_longinteger_T_clear(vector_longinteger_T self)"},
+	 { "vector_longinteger_T_get_allocator", _wrap_vector_longinteger_T_get_allocator, METH_O, "vector_longinteger_T_get_allocator(vector_longinteger_T self) -> std::vector< unsigned long >::allocator_type"},
+	 { "vector_longinteger_T_pop_back", _wrap_vector_longinteger_T_pop_back, METH_O, "vector_longinteger_T_pop_back(vector_longinteger_T self)"},
+	 { "vector_longinteger_T_erase", _wrap_vector_longinteger_T_erase, METH_VARARGS, "\n"
+		"vector_longinteger_T_erase(vector_longinteger_T self, std::vector< unsigned long >::iterator pos) -> std::vector< unsigned long >::iterator\n"
+		"vector_longinteger_T_erase(vector_longinteger_T self, std::vector< unsigned long >::iterator first, std::vector< unsigned long >::iterator last) -> std::vector< unsigned long >::iterator\n"
 		""},
-	 { "new_vector_longinteger_t", _wrap_new_vector_longinteger_t, METH_VARARGS, "\n"
-		"vector_longinteger_t()\n"
-		"vector_longinteger_t(vector_longinteger_t other)\n"
-		"vector_longinteger_t(std::vector< unsigned long >::size_type size)\n"
-		"new_vector_longinteger_t(std::vector< unsigned long >::size_type size, std::vector< unsigned long >::value_type const & value) -> vector_longinteger_t\n"
+	 { "new_vector_longinteger_T", _wrap_new_vector_longinteger_T, METH_VARARGS, "\n"
+		"vector_longinteger_T()\n"
+		"vector_longinteger_T(vector_longinteger_T other)\n"
+		"vector_longinteger_T(std::vector< unsigned long >::size_type size)\n"
+		"new_vector_longinteger_T(std::vector< unsigned long >::size_type size, std::vector< unsigned long >::value_type const & value) -> vector_longinteger_T\n"
 		""},
-	 { "vector_longinteger_t_push_back", _wrap_vector_longinteger_t_push_back, METH_VARARGS, "vector_longinteger_t_push_back(vector_longinteger_t self, std::vector< unsigned long >::value_type const & x)"},
-	 { "vector_longinteger_t_front", _wrap_vector_longinteger_t_front, METH_O, "vector_longinteger_t_front(vector_longinteger_t self) -> std::vector< unsigned long >::value_type const &"},
-	 { "vector_longinteger_t_back", _wrap_vector_longinteger_t_back, METH_O, "vector_longinteger_t_back(vector_longinteger_t self) -> std::vector< unsigned long >::value_type const &"},
-	 { "vector_longinteger_t_assign", _wrap_vector_longinteger_t_assign, METH_VARARGS, "vector_longinteger_t_assign(vector_longinteger_t self, std::vector< unsigned long >::size_type n, std::vector< unsigned long >::value_type const & x)"},
-	 { "vector_longinteger_t_resize", _wrap_vector_longinteger_t_resize, METH_VARARGS, "\n"
-		"vector_longinteger_t_resize(vector_longinteger_t self, std::vector< unsigned long >::size_type new_size)\n"
-		"vector_longinteger_t_resize(vector_longinteger_t self, std::vector< unsigned long >::size_type new_size, std::vector< unsigned long >::value_type const & x)\n"
+	 { "vector_longinteger_T_push_back", _wrap_vector_longinteger_T_push_back, METH_VARARGS, "vector_longinteger_T_push_back(vector_longinteger_T self, std::vector< unsigned long >::value_type const & x)"},
+	 { "vector_longinteger_T_front", _wrap_vector_longinteger_T_front, METH_O, "vector_longinteger_T_front(vector_longinteger_T self) -> std::vector< unsigned long >::value_type const &"},
+	 { "vector_longinteger_T_back", _wrap_vector_longinteger_T_back, METH_O, "vector_longinteger_T_back(vector_longinteger_T self) -> std::vector< unsigned long >::value_type const &"},
+	 { "vector_longinteger_T_assign", _wrap_vector_longinteger_T_assign, METH_VARARGS, "vector_longinteger_T_assign(vector_longinteger_T self, std::vector< unsigned long >::size_type n, std::vector< unsigned long >::value_type const & x)"},
+	 { "vector_longinteger_T_resize", _wrap_vector_longinteger_T_resize, METH_VARARGS, "\n"
+		"vector_longinteger_T_resize(vector_longinteger_T self, std::vector< unsigned long >::size_type new_size)\n"
+		"vector_longinteger_T_resize(vector_longinteger_T self, std::vector< unsigned long >::size_type new_size, std::vector< unsigned long >::value_type const & x)\n"
 		""},
-	 { "vector_longinteger_t_insert", _wrap_vector_longinteger_t_insert, METH_VARARGS, "\n"
-		"vector_longinteger_t_insert(vector_longinteger_t self, std::vector< unsigned long >::iterator pos, std::vector< unsigned long >::value_type const & x) -> std::vector< unsigned long >::iterator\n"
-		"vector_longinteger_t_insert(vector_longinteger_t self, std::vector< unsigned long >::iterator pos, std::vector< unsigned long >::size_type n, std::vector< unsigned long >::value_type const & x)\n"
+	 { "vector_longinteger_T_insert", _wrap_vector_longinteger_T_insert, METH_VARARGS, "\n"
+		"vector_longinteger_T_insert(vector_longinteger_T self, std::vector< unsigned long >::iterator pos, std::vector< unsigned long >::value_type const & x) -> std::vector< unsigned long >::iterator\n"
+		"vector_longinteger_T_insert(vector_longinteger_T self, std::vector< unsigned long >::iterator pos, std::vector< unsigned long >::size_type n, std::vector< unsigned long >::value_type const & x)\n"
 		""},
-	 { "vector_longinteger_t_reserve", _wrap_vector_longinteger_t_reserve, METH_VARARGS, "vector_longinteger_t_reserve(vector_longinteger_t self, std::vector< unsigned long >::size_type n)"},
-	 { "vector_longinteger_t_capacity", _wrap_vector_longinteger_t_capacity, METH_O, "vector_longinteger_t_capacity(vector_longinteger_t self) -> std::vector< unsigned long >::size_type"},
-	 { "delete_vector_longinteger_t", _wrap_delete_vector_longinteger_t, METH_O, "delete_vector_longinteger_t(vector_longinteger_t self)"},
-	 { "vector_longinteger_t_swigregister", vector_longinteger_t_swigregister, METH_O, NULL},
-	 { "vector_longinteger_t_swiginit", vector_longinteger_t_swiginit, METH_VARARGS, NULL},
-	 { "vector_complex_t_iterator", _wrap_vector_complex_t_iterator, METH_O, "vector_complex_t_iterator(vector_complex_t self) -> SwigPyIterator"},
-	 { "vector_complex_t___nonzero__", _wrap_vector_complex_t___nonzero__, METH_O, "vector_complex_t___nonzero__(vector_complex_t self) -> bool"},
-	 { "vector_complex_t___bool__", _wrap_vector_complex_t___bool__, METH_O, "vector_complex_t___bool__(vector_complex_t self) -> bool"},
-	 { "vector_complex_t___len__", _wrap_vector_complex_t___len__, METH_O, "vector_complex_t___len__(vector_complex_t self) -> std::vector< std::complex< double > >::size_type"},
-	 { "vector_complex_t___getslice__", _wrap_vector_complex_t___getslice__, METH_VARARGS, "vector_complex_t___getslice__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j) -> vector_complex_t"},
-	 { "vector_complex_t___setslice__", _wrap_vector_complex_t___setslice__, METH_VARARGS, "\n"
-		"vector_complex_t___setslice__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j)\n"
-		"vector_complex_t___setslice__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j, vector_complex_t v)\n"
+	 { "vector_longinteger_T_reserve", _wrap_vector_longinteger_T_reserve, METH_VARARGS, "vector_longinteger_T_reserve(vector_longinteger_T self, std::vector< unsigned long >::size_type n)"},
+	 { "vector_longinteger_T_capacity", _wrap_vector_longinteger_T_capacity, METH_O, "vector_longinteger_T_capacity(vector_longinteger_T self) -> std::vector< unsigned long >::size_type"},
+	 { "delete_vector_longinteger_T", _wrap_delete_vector_longinteger_T, METH_O, "delete_vector_longinteger_T(vector_longinteger_T self)"},
+	 { "vector_longinteger_T_swigregister", vector_longinteger_T_swigregister, METH_O, NULL},
+	 { "vector_longinteger_T_swiginit", vector_longinteger_T_swiginit, METH_VARARGS, NULL},
+	 { "vector_complex_T_iterator", _wrap_vector_complex_T_iterator, METH_O, "vector_complex_T_iterator(vector_complex_T self) -> SwigPyIterator"},
+	 { "vector_complex_T___nonzero__", _wrap_vector_complex_T___nonzero__, METH_O, "vector_complex_T___nonzero__(vector_complex_T self) -> bool"},
+	 { "vector_complex_T___bool__", _wrap_vector_complex_T___bool__, METH_O, "vector_complex_T___bool__(vector_complex_T self) -> bool"},
+	 { "vector_complex_T___len__", _wrap_vector_complex_T___len__, METH_O, "vector_complex_T___len__(vector_complex_T self) -> std::vector< std::complex< double > >::size_type"},
+	 { "vector_complex_T___getslice__", _wrap_vector_complex_T___getslice__, METH_VARARGS, "vector_complex_T___getslice__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j) -> vector_complex_T"},
+	 { "vector_complex_T___setslice__", _wrap_vector_complex_T___setslice__, METH_VARARGS, "\n"
+		"vector_complex_T___setslice__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j)\n"
+		"vector_complex_T___setslice__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j, vector_complex_T v)\n"
 		""},
-	 { "vector_complex_t___delslice__", _wrap_vector_complex_t___delslice__, METH_VARARGS, "vector_complex_t___delslice__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j)"},
-	 { "vector_complex_t___delitem__", _wrap_vector_complex_t___delitem__, METH_VARARGS, "\n"
-		"vector_complex_t___delitem__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i)\n"
-		"vector_complex_t___delitem__(vector_complex_t self, SWIGPY_SLICEOBJECT * slice)\n"
+	 { "vector_complex_T___delslice__", _wrap_vector_complex_T___delslice__, METH_VARARGS, "vector_complex_T___delslice__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j)"},
+	 { "vector_complex_T___delitem__", _wrap_vector_complex_T___delitem__, METH_VARARGS, "\n"
+		"vector_complex_T___delitem__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i)\n"
+		"vector_complex_T___delitem__(vector_complex_T self, SWIGPY_SLICEOBJECT * slice)\n"
 		""},
-	 { "vector_complex_t___getitem__", _wrap_vector_complex_t___getitem__, METH_VARARGS, "\n"
-		"vector_complex_t___getitem__(vector_complex_t self, SWIGPY_SLICEOBJECT * slice) -> vector_complex_t\n"
-		"vector_complex_t___getitem__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i) -> std::vector< std::complex< double > >::value_type const &\n"
+	 { "vector_complex_T___getitem__", _wrap_vector_complex_T___getitem__, METH_VARARGS, "\n"
+		"vector_complex_T___getitem__(vector_complex_T self, SWIGPY_SLICEOBJECT * slice) -> vector_complex_T\n"
+		"vector_complex_T___getitem__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i) -> std::vector< std::complex< double > >::value_type const &\n"
 		""},
-	 { "vector_complex_t___setitem__", _wrap_vector_complex_t___setitem__, METH_VARARGS, "\n"
-		"vector_complex_t___setitem__(vector_complex_t self, SWIGPY_SLICEOBJECT * slice, vector_complex_t v)\n"
-		"vector_complex_t___setitem__(vector_complex_t self, SWIGPY_SLICEOBJECT * slice)\n"
-		"vector_complex_t___setitem__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::value_type const & x)\n"
+	 { "vector_complex_T___setitem__", _wrap_vector_complex_T___setitem__, METH_VARARGS, "\n"
+		"vector_complex_T___setitem__(vector_complex_T self, SWIGPY_SLICEOBJECT * slice, vector_complex_T v)\n"
+		"vector_complex_T___setitem__(vector_complex_T self, SWIGPY_SLICEOBJECT * slice)\n"
+		"vector_complex_T___setitem__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::value_type const & x)\n"
 		""},
-	 { "vector_complex_t_pop", _wrap_vector_complex_t_pop, METH_O, "vector_complex_t_pop(vector_complex_t self) -> std::vector< std::complex< double > >::value_type"},
-	 { "vector_complex_t_append", _wrap_vector_complex_t_append, METH_VARARGS, "vector_complex_t_append(vector_complex_t self, std::vector< std::complex< double > >::value_type const & x)"},
-	 { "vector_complex_t_empty", _wrap_vector_complex_t_empty, METH_O, "vector_complex_t_empty(vector_complex_t self) -> bool"},
-	 { "vector_complex_t_size", _wrap_vector_complex_t_size, METH_O, "vector_complex_t_size(vector_complex_t self) -> std::vector< std::complex< double > >::size_type"},
-	 { "vector_complex_t_swap", _wrap_vector_complex_t_swap, METH_VARARGS, "vector_complex_t_swap(vector_complex_t self, vector_complex_t v)"},
-	 { "vector_complex_t_begin", _wrap_vector_complex_t_begin, METH_O, "vector_complex_t_begin(vector_complex_t self) -> std::vector< std::complex< double > >::iterator"},
-	 { "vector_complex_t_end", _wrap_vector_complex_t_end, METH_O, "vector_complex_t_end(vector_complex_t self) -> std::vector< std::complex< double > >::iterator"},
-	 { "vector_complex_t_rbegin", _wrap_vector_complex_t_rbegin, METH_O, "vector_complex_t_rbegin(vector_complex_t self) -> std::vector< std::complex< double > >::reverse_iterator"},
-	 { "vector_complex_t_rend", _wrap_vector_complex_t_rend, METH_O, "vector_complex_t_rend(vector_complex_t self) -> std::vector< std::complex< double > >::reverse_iterator"},
-	 { "vector_complex_t_clear", _wrap_vector_complex_t_clear, METH_O, "vector_complex_t_clear(vector_complex_t self)"},
-	 { "vector_complex_t_get_allocator", _wrap_vector_complex_t_get_allocator, METH_O, "vector_complex_t_get_allocator(vector_complex_t self) -> std::vector< std::complex< double > >::allocator_type"},
-	 { "vector_complex_t_pop_back", _wrap_vector_complex_t_pop_back, METH_O, "vector_complex_t_pop_back(vector_complex_t self)"},
-	 { "vector_complex_t_erase", _wrap_vector_complex_t_erase, METH_VARARGS, "\n"
-		"vector_complex_t_erase(vector_complex_t self, std::vector< std::complex< double > >::iterator pos) -> std::vector< std::complex< double > >::iterator\n"
-		"vector_complex_t_erase(vector_complex_t self, std::vector< std::complex< double > >::iterator first, std::vector< std::complex< double > >::iterator last) -> std::vector< std::complex< double > >::iterator\n"
+	 { "vector_complex_T_pop", _wrap_vector_complex_T_pop, METH_O, "vector_complex_T_pop(vector_complex_T self) -> std::vector< std::complex< double > >::value_type"},
+	 { "vector_complex_T_append", _wrap_vector_complex_T_append, METH_VARARGS, "vector_complex_T_append(vector_complex_T self, std::vector< std::complex< double > >::value_type const & x)"},
+	 { "vector_complex_T_empty", _wrap_vector_complex_T_empty, METH_O, "vector_complex_T_empty(vector_complex_T self) -> bool"},
+	 { "vector_complex_T_size", _wrap_vector_complex_T_size, METH_O, "vector_complex_T_size(vector_complex_T self) -> std::vector< std::complex< double > >::size_type"},
+	 { "vector_complex_T_swap", _wrap_vector_complex_T_swap, METH_VARARGS, "vector_complex_T_swap(vector_complex_T self, vector_complex_T v)"},
+	 { "vector_complex_T_begin", _wrap_vector_complex_T_begin, METH_O, "vector_complex_T_begin(vector_complex_T self) -> std::vector< std::complex< double > >::iterator"},
+	 { "vector_complex_T_end", _wrap_vector_complex_T_end, METH_O, "vector_complex_T_end(vector_complex_T self) -> std::vector< std::complex< double > >::iterator"},
+	 { "vector_complex_T_rbegin", _wrap_vector_complex_T_rbegin, METH_O, "vector_complex_T_rbegin(vector_complex_T self) -> std::vector< std::complex< double > >::reverse_iterator"},
+	 { "vector_complex_T_rend", _wrap_vector_complex_T_rend, METH_O, "vector_complex_T_rend(vector_complex_T self) -> std::vector< std::complex< double > >::reverse_iterator"},
+	 { "vector_complex_T_clear", _wrap_vector_complex_T_clear, METH_O, "vector_complex_T_clear(vector_complex_T self)"},
+	 { "vector_complex_T_get_allocator", _wrap_vector_complex_T_get_allocator, METH_O, "vector_complex_T_get_allocator(vector_complex_T self) -> std::vector< std::complex< double > >::allocator_type"},
+	 { "vector_complex_T_pop_back", _wrap_vector_complex_T_pop_back, METH_O, "vector_complex_T_pop_back(vector_complex_T self)"},
+	 { "vector_complex_T_erase", _wrap_vector_complex_T_erase, METH_VARARGS, "\n"
+		"vector_complex_T_erase(vector_complex_T self, std::vector< std::complex< double > >::iterator pos) -> std::vector< std::complex< double > >::iterator\n"
+		"vector_complex_T_erase(vector_complex_T self, std::vector< std::complex< double > >::iterator first, std::vector< std::complex< double > >::iterator last) -> std::vector< std::complex< double > >::iterator\n"
 		""},
-	 { "new_vector_complex_t", _wrap_new_vector_complex_t, METH_VARARGS, "\n"
-		"vector_complex_t()\n"
-		"vector_complex_t(vector_complex_t other)\n"
-		"vector_complex_t(std::vector< std::complex< double > >::size_type size)\n"
-		"new_vector_complex_t(std::vector< std::complex< double > >::size_type size, std::vector< std::complex< double > >::value_type const & value) -> vector_complex_t\n"
+	 { "new_vector_complex_T", _wrap_new_vector_complex_T, METH_VARARGS, "\n"
+		"vector_complex_T()\n"
+		"vector_complex_T(vector_complex_T other)\n"
+		"vector_complex_T(std::vector< std::complex< double > >::size_type size)\n"
+		"new_vector_complex_T(std::vector< std::complex< double > >::size_type size, std::vector< std::complex< double > >::value_type const & value) -> vector_complex_T\n"
 		""},
-	 { "vector_complex_t_push_back", _wrap_vector_complex_t_push_back, METH_VARARGS, "vector_complex_t_push_back(vector_complex_t self, std::vector< std::complex< double > >::value_type const & x)"},
-	 { "vector_complex_t_front", _wrap_vector_complex_t_front, METH_O, "vector_complex_t_front(vector_complex_t self) -> std::vector< std::complex< double > >::value_type const &"},
-	 { "vector_complex_t_back", _wrap_vector_complex_t_back, METH_O, "vector_complex_t_back(vector_complex_t self) -> std::vector< std::complex< double > >::value_type const &"},
-	 { "vector_complex_t_assign", _wrap_vector_complex_t_assign, METH_VARARGS, "vector_complex_t_assign(vector_complex_t self, std::vector< std::complex< double > >::size_type n, std::vector< std::complex< double > >::value_type const & x)"},
-	 { "vector_complex_t_resize", _wrap_vector_complex_t_resize, METH_VARARGS, "\n"
-		"vector_complex_t_resize(vector_complex_t self, std::vector< std::complex< double > >::size_type new_size)\n"
-		"vector_complex_t_resize(vector_complex_t self, std::vector< std::complex< double > >::size_type new_size, std::vector< std::complex< double > >::value_type const & x)\n"
+	 { "vector_complex_T_push_back", _wrap_vector_complex_T_push_back, METH_VARARGS, "vector_complex_T_push_back(vector_complex_T self, std::vector< std::complex< double > >::value_type const & x)"},
+	 { "vector_complex_T_front", _wrap_vector_complex_T_front, METH_O, "vector_complex_T_front(vector_complex_T self) -> std::vector< std::complex< double > >::value_type const &"},
+	 { "vector_complex_T_back", _wrap_vector_complex_T_back, METH_O, "vector_complex_T_back(vector_complex_T self) -> std::vector< std::complex< double > >::value_type const &"},
+	 { "vector_complex_T_assign", _wrap_vector_complex_T_assign, METH_VARARGS, "vector_complex_T_assign(vector_complex_T self, std::vector< std::complex< double > >::size_type n, std::vector< std::complex< double > >::value_type const & x)"},
+	 { "vector_complex_T_resize", _wrap_vector_complex_T_resize, METH_VARARGS, "\n"
+		"vector_complex_T_resize(vector_complex_T self, std::vector< std::complex< double > >::size_type new_size)\n"
+		"vector_complex_T_resize(vector_complex_T self, std::vector< std::complex< double > >::size_type new_size, std::vector< std::complex< double > >::value_type const & x)\n"
 		""},
-	 { "vector_complex_t_insert", _wrap_vector_complex_t_insert, METH_VARARGS, "\n"
-		"vector_complex_t_insert(vector_complex_t self, std::vector< std::complex< double > >::iterator pos, std::vector< std::complex< double > >::value_type const & x) -> std::vector< std::complex< double > >::iterator\n"
-		"vector_complex_t_insert(vector_complex_t self, std::vector< std::complex< double > >::iterator pos, std::vector< std::complex< double > >::size_type n, std::vector< std::complex< double > >::value_type const & x)\n"
+	 { "vector_complex_T_insert", _wrap_vector_complex_T_insert, METH_VARARGS, "\n"
+		"vector_complex_T_insert(vector_complex_T self, std::vector< std::complex< double > >::iterator pos, std::vector< std::complex< double > >::value_type const & x) -> std::vector< std::complex< double > >::iterator\n"
+		"vector_complex_T_insert(vector_complex_T self, std::vector< std::complex< double > >::iterator pos, std::vector< std::complex< double > >::size_type n, std::vector< std::complex< double > >::value_type const & x)\n"
 		""},
-	 { "vector_complex_t_reserve", _wrap_vector_complex_t_reserve, METH_VARARGS, "vector_complex_t_reserve(vector_complex_t self, std::vector< std::complex< double > >::size_type n)"},
-	 { "vector_complex_t_capacity", _wrap_vector_complex_t_capacity, METH_O, "vector_complex_t_capacity(vector_complex_t self) -> std::vector< std::complex< double > >::size_type"},
-	 { "delete_vector_complex_t", _wrap_delete_vector_complex_t, METH_O, "delete_vector_complex_t(vector_complex_t self)"},
-	 { "vector_complex_t_swigregister", vector_complex_t_swigregister, METH_O, NULL},
-	 { "vector_complex_t_swiginit", vector_complex_t_swiginit, METH_VARARGS, NULL},
-	 { "vector_string_t_iterator", _wrap_vector_string_t_iterator, METH_O, "vector_string_t_iterator(vector_string_t self) -> SwigPyIterator"},
-	 { "vector_string_t___nonzero__", _wrap_vector_string_t___nonzero__, METH_O, "vector_string_t___nonzero__(vector_string_t self) -> bool"},
-	 { "vector_string_t___bool__", _wrap_vector_string_t___bool__, METH_O, "vector_string_t___bool__(vector_string_t self) -> bool"},
-	 { "vector_string_t___len__", _wrap_vector_string_t___len__, METH_O, "vector_string_t___len__(vector_string_t self) -> std::vector< std::string >::size_type"},
-	 { "vector_string_t___getslice__", _wrap_vector_string_t___getslice__, METH_VARARGS, "vector_string_t___getslice__(vector_string_t self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j) -> vector_string_t"},
-	 { "vector_string_t___setslice__", _wrap_vector_string_t___setslice__, METH_VARARGS, "\n"
-		"vector_string_t___setslice__(vector_string_t self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j)\n"
-		"vector_string_t___setslice__(vector_string_t self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j, vector_string_t v)\n"
+	 { "vector_complex_T_reserve", _wrap_vector_complex_T_reserve, METH_VARARGS, "vector_complex_T_reserve(vector_complex_T self, std::vector< std::complex< double > >::size_type n)"},
+	 { "vector_complex_T_capacity", _wrap_vector_complex_T_capacity, METH_O, "vector_complex_T_capacity(vector_complex_T self) -> std::vector< std::complex< double > >::size_type"},
+	 { "delete_vector_complex_T", _wrap_delete_vector_complex_T, METH_O, "delete_vector_complex_T(vector_complex_T self)"},
+	 { "vector_complex_T_swigregister", vector_complex_T_swigregister, METH_O, NULL},
+	 { "vector_complex_T_swiginit", vector_complex_T_swiginit, METH_VARARGS, NULL},
+	 { "vector_string_T_iterator", _wrap_vector_string_T_iterator, METH_O, "vector_string_T_iterator(vector_string_T self) -> SwigPyIterator"},
+	 { "vector_string_T___nonzero__", _wrap_vector_string_T___nonzero__, METH_O, "vector_string_T___nonzero__(vector_string_T self) -> bool"},
+	 { "vector_string_T___bool__", _wrap_vector_string_T___bool__, METH_O, "vector_string_T___bool__(vector_string_T self) -> bool"},
+	 { "vector_string_T___len__", _wrap_vector_string_T___len__, METH_O, "vector_string_T___len__(vector_string_T self) -> std::vector< std::string >::size_type"},
+	 { "vector_string_T___getslice__", _wrap_vector_string_T___getslice__, METH_VARARGS, "vector_string_T___getslice__(vector_string_T self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j) -> vector_string_T"},
+	 { "vector_string_T___setslice__", _wrap_vector_string_T___setslice__, METH_VARARGS, "\n"
+		"vector_string_T___setslice__(vector_string_T self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j)\n"
+		"vector_string_T___setslice__(vector_string_T self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j, vector_string_T v)\n"
 		""},
-	 { "vector_string_t___delslice__", _wrap_vector_string_t___delslice__, METH_VARARGS, "vector_string_t___delslice__(vector_string_t self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j)"},
-	 { "vector_string_t___delitem__", _wrap_vector_string_t___delitem__, METH_VARARGS, "\n"
-		"vector_string_t___delitem__(vector_string_t self, std::vector< std::string >::difference_type i)\n"
-		"vector_string_t___delitem__(vector_string_t self, SWIGPY_SLICEOBJECT * slice)\n"
+	 { "vector_string_T___delslice__", _wrap_vector_string_T___delslice__, METH_VARARGS, "vector_string_T___delslice__(vector_string_T self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j)"},
+	 { "vector_string_T___delitem__", _wrap_vector_string_T___delitem__, METH_VARARGS, "\n"
+		"vector_string_T___delitem__(vector_string_T self, std::vector< std::string >::difference_type i)\n"
+		"vector_string_T___delitem__(vector_string_T self, SWIGPY_SLICEOBJECT * slice)\n"
 		""},
-	 { "vector_string_t___getitem__", _wrap_vector_string_t___getitem__, METH_VARARGS, "\n"
-		"vector_string_t___getitem__(vector_string_t self, SWIGPY_SLICEOBJECT * slice) -> vector_string_t\n"
-		"vector_string_t___getitem__(vector_string_t self, std::vector< std::string >::difference_type i) -> std::vector< std::string >::value_type const &\n"
+	 { "vector_string_T___getitem__", _wrap_vector_string_T___getitem__, METH_VARARGS, "\n"
+		"vector_string_T___getitem__(vector_string_T self, SWIGPY_SLICEOBJECT * slice) -> vector_string_T\n"
+		"vector_string_T___getitem__(vector_string_T self, std::vector< std::string >::difference_type i) -> std::vector< std::string >::value_type const &\n"
 		""},
-	 { "vector_string_t___setitem__", _wrap_vector_string_t___setitem__, METH_VARARGS, "\n"
-		"vector_string_t___setitem__(vector_string_t self, SWIGPY_SLICEOBJECT * slice, vector_string_t v)\n"
-		"vector_string_t___setitem__(vector_string_t self, SWIGPY_SLICEOBJECT * slice)\n"
-		"vector_string_t___setitem__(vector_string_t self, std::vector< std::string >::difference_type i, std::vector< std::string >::value_type const & x)\n"
+	 { "vector_string_T___setitem__", _wrap_vector_string_T___setitem__, METH_VARARGS, "\n"
+		"vector_string_T___setitem__(vector_string_T self, SWIGPY_SLICEOBJECT * slice, vector_string_T v)\n"
+		"vector_string_T___setitem__(vector_string_T self, SWIGPY_SLICEOBJECT * slice)\n"
+		"vector_string_T___setitem__(vector_string_T self, std::vector< std::string >::difference_type i, std::vector< std::string >::value_type const & x)\n"
 		""},
-	 { "vector_string_t_pop", _wrap_vector_string_t_pop, METH_O, "vector_string_t_pop(vector_string_t self) -> std::vector< std::string >::value_type"},
-	 { "vector_string_t_append", _wrap_vector_string_t_append, METH_VARARGS, "vector_string_t_append(vector_string_t self, std::vector< std::string >::value_type const & x)"},
-	 { "vector_string_t_empty", _wrap_vector_string_t_empty, METH_O, "vector_string_t_empty(vector_string_t self) -> bool"},
-	 { "vector_string_t_size", _wrap_vector_string_t_size, METH_O, "vector_string_t_size(vector_string_t self) -> std::vector< std::string >::size_type"},
-	 { "vector_string_t_swap", _wrap_vector_string_t_swap, METH_VARARGS, "vector_string_t_swap(vector_string_t self, vector_string_t v)"},
-	 { "vector_string_t_begin", _wrap_vector_string_t_begin, METH_O, "vector_string_t_begin(vector_string_t self) -> std::vector< std::string >::iterator"},
-	 { "vector_string_t_end", _wrap_vector_string_t_end, METH_O, "vector_string_t_end(vector_string_t self) -> std::vector< std::string >::iterator"},
-	 { "vector_string_t_rbegin", _wrap_vector_string_t_rbegin, METH_O, "vector_string_t_rbegin(vector_string_t self) -> std::vector< std::string >::reverse_iterator"},
-	 { "vector_string_t_rend", _wrap_vector_string_t_rend, METH_O, "vector_string_t_rend(vector_string_t self) -> std::vector< std::string >::reverse_iterator"},
-	 { "vector_string_t_clear", _wrap_vector_string_t_clear, METH_O, "vector_string_t_clear(vector_string_t self)"},
-	 { "vector_string_t_get_allocator", _wrap_vector_string_t_get_allocator, METH_O, "vector_string_t_get_allocator(vector_string_t self) -> std::vector< std::string >::allocator_type"},
-	 { "vector_string_t_pop_back", _wrap_vector_string_t_pop_back, METH_O, "vector_string_t_pop_back(vector_string_t self)"},
-	 { "vector_string_t_erase", _wrap_vector_string_t_erase, METH_VARARGS, "\n"
-		"vector_string_t_erase(vector_string_t self, std::vector< std::string >::iterator pos) -> std::vector< std::string >::iterator\n"
-		"vector_string_t_erase(vector_string_t self, std::vector< std::string >::iterator first, std::vector< std::string >::iterator last) -> std::vector< std::string >::iterator\n"
+	 { "vector_string_T_pop", _wrap_vector_string_T_pop, METH_O, "vector_string_T_pop(vector_string_T self) -> std::vector< std::string >::value_type"},
+	 { "vector_string_T_append", _wrap_vector_string_T_append, METH_VARARGS, "vector_string_T_append(vector_string_T self, std::vector< std::string >::value_type const & x)"},
+	 { "vector_string_T_empty", _wrap_vector_string_T_empty, METH_O, "vector_string_T_empty(vector_string_T self) -> bool"},
+	 { "vector_string_T_size", _wrap_vector_string_T_size, METH_O, "vector_string_T_size(vector_string_T self) -> std::vector< std::string >::size_type"},
+	 { "vector_string_T_swap", _wrap_vector_string_T_swap, METH_VARARGS, "vector_string_T_swap(vector_string_T self, vector_string_T v)"},
+	 { "vector_string_T_begin", _wrap_vector_string_T_begin, METH_O, "vector_string_T_begin(vector_string_T self) -> std::vector< std::string >::iterator"},
+	 { "vector_string_T_end", _wrap_vector_string_T_end, METH_O, "vector_string_T_end(vector_string_T self) -> std::vector< std::string >::iterator"},
+	 { "vector_string_T_rbegin", _wrap_vector_string_T_rbegin, METH_O, "vector_string_T_rbegin(vector_string_T self) -> std::vector< std::string >::reverse_iterator"},
+	 { "vector_string_T_rend", _wrap_vector_string_T_rend, METH_O, "vector_string_T_rend(vector_string_T self) -> std::vector< std::string >::reverse_iterator"},
+	 { "vector_string_T_clear", _wrap_vector_string_T_clear, METH_O, "vector_string_T_clear(vector_string_T self)"},
+	 { "vector_string_T_get_allocator", _wrap_vector_string_T_get_allocator, METH_O, "vector_string_T_get_allocator(vector_string_T self) -> std::vector< std::string >::allocator_type"},
+	 { "vector_string_T_pop_back", _wrap_vector_string_T_pop_back, METH_O, "vector_string_T_pop_back(vector_string_T self)"},
+	 { "vector_string_T_erase", _wrap_vector_string_T_erase, METH_VARARGS, "\n"
+		"vector_string_T_erase(vector_string_T self, std::vector< std::string >::iterator pos) -> std::vector< std::string >::iterator\n"
+		"vector_string_T_erase(vector_string_T self, std::vector< std::string >::iterator first, std::vector< std::string >::iterator last) -> std::vector< std::string >::iterator\n"
 		""},
-	 { "new_vector_string_t", _wrap_new_vector_string_t, METH_VARARGS, "\n"
-		"vector_string_t()\n"
-		"vector_string_t(vector_string_t other)\n"
-		"vector_string_t(std::vector< std::string >::size_type size)\n"
-		"new_vector_string_t(std::vector< std::string >::size_type size, std::vector< std::string >::value_type const & value) -> vector_string_t\n"
+	 { "new_vector_string_T", _wrap_new_vector_string_T, METH_VARARGS, "\n"
+		"vector_string_T()\n"
+		"vector_string_T(vector_string_T other)\n"
+		"vector_string_T(std::vector< std::string >::size_type size)\n"
+		"new_vector_string_T(std::vector< std::string >::size_type size, std::vector< std::string >::value_type const & value) -> vector_string_T\n"
 		""},
-	 { "vector_string_t_push_back", _wrap_vector_string_t_push_back, METH_VARARGS, "vector_string_t_push_back(vector_string_t self, std::vector< std::string >::value_type const & x)"},
-	 { "vector_string_t_front", _wrap_vector_string_t_front, METH_O, "vector_string_t_front(vector_string_t self) -> std::vector< std::string >::value_type const &"},
-	 { "vector_string_t_back", _wrap_vector_string_t_back, METH_O, "vector_string_t_back(vector_string_t self) -> std::vector< std::string >::value_type const &"},
-	 { "vector_string_t_assign", _wrap_vector_string_t_assign, METH_VARARGS, "vector_string_t_assign(vector_string_t self, std::vector< std::string >::size_type n, std::vector< std::string >::value_type const & x)"},
-	 { "vector_string_t_resize", _wrap_vector_string_t_resize, METH_VARARGS, "\n"
-		"vector_string_t_resize(vector_string_t self, std::vector< std::string >::size_type new_size)\n"
-		"vector_string_t_resize(vector_string_t self, std::vector< std::string >::size_type new_size, std::vector< std::string >::value_type const & x)\n"
+	 { "vector_string_T_push_back", _wrap_vector_string_T_push_back, METH_VARARGS, "vector_string_T_push_back(vector_string_T self, std::vector< std::string >::value_type const & x)"},
+	 { "vector_string_T_front", _wrap_vector_string_T_front, METH_O, "vector_string_T_front(vector_string_T self) -> std::vector< std::string >::value_type const &"},
+	 { "vector_string_T_back", _wrap_vector_string_T_back, METH_O, "vector_string_T_back(vector_string_T self) -> std::vector< std::string >::value_type const &"},
+	 { "vector_string_T_assign", _wrap_vector_string_T_assign, METH_VARARGS, "vector_string_T_assign(vector_string_T self, std::vector< std::string >::size_type n, std::vector< std::string >::value_type const & x)"},
+	 { "vector_string_T_resize", _wrap_vector_string_T_resize, METH_VARARGS, "\n"
+		"vector_string_T_resize(vector_string_T self, std::vector< std::string >::size_type new_size)\n"
+		"vector_string_T_resize(vector_string_T self, std::vector< std::string >::size_type new_size, std::vector< std::string >::value_type const & x)\n"
 		""},
-	 { "vector_string_t_insert", _wrap_vector_string_t_insert, METH_VARARGS, "\n"
-		"vector_string_t_insert(vector_string_t self, std::vector< std::string >::iterator pos, std::vector< std::string >::value_type const & x) -> std::vector< std::string >::iterator\n"
-		"vector_string_t_insert(vector_string_t self, std::vector< std::string >::iterator pos, std::vector< std::string >::size_type n, std::vector< std::string >::value_type const & x)\n"
+	 { "vector_string_T_insert", _wrap_vector_string_T_insert, METH_VARARGS, "\n"
+		"vector_string_T_insert(vector_string_T self, std::vector< std::string >::iterator pos, std::vector< std::string >::value_type const & x) -> std::vector< std::string >::iterator\n"
+		"vector_string_T_insert(vector_string_T self, std::vector< std::string >::iterator pos, std::vector< std::string >::size_type n, std::vector< std::string >::value_type const & x)\n"
 		""},
-	 { "vector_string_t_reserve", _wrap_vector_string_t_reserve, METH_VARARGS, "vector_string_t_reserve(vector_string_t self, std::vector< std::string >::size_type n)"},
-	 { "vector_string_t_capacity", _wrap_vector_string_t_capacity, METH_O, "vector_string_t_capacity(vector_string_t self) -> std::vector< std::string >::size_type"},
-	 { "delete_vector_string_t", _wrap_delete_vector_string_t, METH_O, "delete_vector_string_t(vector_string_t self)"},
-	 { "vector_string_t_swigregister", vector_string_t_swigregister, METH_O, NULL},
-	 { "vector_string_t_swiginit", vector_string_t_swiginit, METH_VARARGS, NULL},
-	 { "map_string_double_t_iterator", _wrap_map_string_double_t_iterator, METH_O, "map_string_double_t_iterator(map_string_double_t self) -> SwigPyIterator"},
-	 { "map_string_double_t___nonzero__", _wrap_map_string_double_t___nonzero__, METH_O, "map_string_double_t___nonzero__(map_string_double_t self) -> bool"},
-	 { "map_string_double_t___bool__", _wrap_map_string_double_t___bool__, METH_O, "map_string_double_t___bool__(map_string_double_t self) -> bool"},
-	 { "map_string_double_t___len__", _wrap_map_string_double_t___len__, METH_O, "map_string_double_t___len__(map_string_double_t self) -> std::map< std::string,double >::size_type"},
-	 { "map_string_double_t___getitem__", _wrap_map_string_double_t___getitem__, METH_VARARGS, "map_string_double_t___getitem__(map_string_double_t self, std::map< std::string,double >::key_type const & key) -> std::map< std::string,double >::mapped_type const &"},
-	 { "map_string_double_t___delitem__", _wrap_map_string_double_t___delitem__, METH_VARARGS, "map_string_double_t___delitem__(map_string_double_t self, std::map< std::string,double >::key_type const & key)"},
-	 { "map_string_double_t_has_key", _wrap_map_string_double_t_has_key, METH_VARARGS, "map_string_double_t_has_key(map_string_double_t self, std::map< std::string,double >::key_type const & key) -> bool"},
-	 { "map_string_double_t_keys", _wrap_map_string_double_t_keys, METH_O, "map_string_double_t_keys(map_string_double_t self) -> PyObject *"},
-	 { "map_string_double_t_values", _wrap_map_string_double_t_values, METH_O, "map_string_double_t_values(map_string_double_t self) -> PyObject *"},
-	 { "map_string_double_t_items", _wrap_map_string_double_t_items, METH_O, "map_string_double_t_items(map_string_double_t self) -> PyObject *"},
-	 { "map_string_double_t___contains__", _wrap_map_string_double_t___contains__, METH_VARARGS, "map_string_double_t___contains__(map_string_double_t self, std::map< std::string,double >::key_type const & key) -> bool"},
-	 { "map_string_double_t_key_iterator", _wrap_map_string_double_t_key_iterator, METH_O, "map_string_double_t_key_iterator(map_string_double_t self) -> SwigPyIterator"},
-	 { "map_string_double_t_value_iterator", _wrap_map_string_double_t_value_iterator, METH_O, "map_string_double_t_value_iterator(map_string_double_t self) -> SwigPyIterator"},
-	 { "map_string_double_t___setitem__", _wrap_map_string_double_t___setitem__, METH_VARARGS, "\n"
-		"map_string_double_t___setitem__(map_string_double_t self, std::map< std::string,double >::key_type const & key)\n"
-		"map_string_double_t___setitem__(map_string_double_t self, std::map< std::string,double >::key_type const & key, std::map< std::string,double >::mapped_type const & x)\n"
+	 { "vector_string_T_reserve", _wrap_vector_string_T_reserve, METH_VARARGS, "vector_string_T_reserve(vector_string_T self, std::vector< std::string >::size_type n)"},
+	 { "vector_string_T_capacity", _wrap_vector_string_T_capacity, METH_O, "vector_string_T_capacity(vector_string_T self) -> std::vector< std::string >::size_type"},
+	 { "delete_vector_string_T", _wrap_delete_vector_string_T, METH_O, "delete_vector_string_T(vector_string_T self)"},
+	 { "vector_string_T_swigregister", vector_string_T_swigregister, METH_O, NULL},
+	 { "vector_string_T_swiginit", vector_string_T_swiginit, METH_VARARGS, NULL},
+	 { "map_string_double_T_iterator", _wrap_map_string_double_T_iterator, METH_O, "map_string_double_T_iterator(map_string_double_T self) -> SwigPyIterator"},
+	 { "map_string_double_T___nonzero__", _wrap_map_string_double_T___nonzero__, METH_O, "map_string_double_T___nonzero__(map_string_double_T self) -> bool"},
+	 { "map_string_double_T___bool__", _wrap_map_string_double_T___bool__, METH_O, "map_string_double_T___bool__(map_string_double_T self) -> bool"},
+	 { "map_string_double_T___len__", _wrap_map_string_double_T___len__, METH_O, "map_string_double_T___len__(map_string_double_T self) -> std::map< std::string,double >::size_type"},
+	 { "map_string_double_T___getitem__", _wrap_map_string_double_T___getitem__, METH_VARARGS, "map_string_double_T___getitem__(map_string_double_T self, std::map< std::string,double >::key_type const & key) -> std::map< std::string,double >::mapped_type const &"},
+	 { "map_string_double_T___delitem__", _wrap_map_string_double_T___delitem__, METH_VARARGS, "map_string_double_T___delitem__(map_string_double_T self, std::map< std::string,double >::key_type const & key)"},
+	 { "map_string_double_T_has_key", _wrap_map_string_double_T_has_key, METH_VARARGS, "map_string_double_T_has_key(map_string_double_T self, std::map< std::string,double >::key_type const & key) -> bool"},
+	 { "map_string_double_T_keys", _wrap_map_string_double_T_keys, METH_O, "map_string_double_T_keys(map_string_double_T self) -> PyObject *"},
+	 { "map_string_double_T_values", _wrap_map_string_double_T_values, METH_O, "map_string_double_T_values(map_string_double_T self) -> PyObject *"},
+	 { "map_string_double_T_items", _wrap_map_string_double_T_items, METH_O, "map_string_double_T_items(map_string_double_T self) -> PyObject *"},
+	 { "map_string_double_T___contains__", _wrap_map_string_double_T___contains__, METH_VARARGS, "map_string_double_T___contains__(map_string_double_T self, std::map< std::string,double >::key_type const & key) -> bool"},
+	 { "map_string_double_T_key_iterator", _wrap_map_string_double_T_key_iterator, METH_O, "map_string_double_T_key_iterator(map_string_double_T self) -> SwigPyIterator"},
+	 { "map_string_double_T_value_iterator", _wrap_map_string_double_T_value_iterator, METH_O, "map_string_double_T_value_iterator(map_string_double_T self) -> SwigPyIterator"},
+	 { "map_string_double_T___setitem__", _wrap_map_string_double_T___setitem__, METH_VARARGS, "\n"
+		"map_string_double_T___setitem__(map_string_double_T self, std::map< std::string,double >::key_type const & key)\n"
+		"map_string_double_T___setitem__(map_string_double_T self, std::map< std::string,double >::key_type const & key, std::map< std::string,double >::mapped_type const & x)\n"
 		""},
-	 { "map_string_double_t_asdict", _wrap_map_string_double_t_asdict, METH_O, "map_string_double_t_asdict(map_string_double_t self) -> PyObject *"},
-	 { "new_map_string_double_t", _wrap_new_map_string_double_t, METH_VARARGS, "\n"
-		"map_string_double_t(std::less< std::string > const & other)\n"
-		"map_string_double_t()\n"
-		"new_map_string_double_t(map_string_double_t other) -> map_string_double_t\n"
+	 { "map_string_double_T_asdict", _wrap_map_string_double_T_asdict, METH_O, "map_string_double_T_asdict(map_string_double_T self) -> PyObject *"},
+	 { "new_map_string_double_T", _wrap_new_map_string_double_T, METH_VARARGS, "\n"
+		"map_string_double_T(std::less< std::string > const & other)\n"
+		"map_string_double_T()\n"
+		"new_map_string_double_T(map_string_double_T other) -> map_string_double_T\n"
 		""},
-	 { "map_string_double_t_empty", _wrap_map_string_double_t_empty, METH_O, "map_string_double_t_empty(map_string_double_t self) -> bool"},
-	 { "map_string_double_t_size", _wrap_map_string_double_t_size, METH_O, "map_string_double_t_size(map_string_double_t self) -> std::map< std::string,double >::size_type"},
-	 { "map_string_double_t_swap", _wrap_map_string_double_t_swap, METH_VARARGS, "map_string_double_t_swap(map_string_double_t self, map_string_double_t v)"},
-	 { "map_string_double_t_begin", _wrap_map_string_double_t_begin, METH_O, "map_string_double_t_begin(map_string_double_t self) -> std::map< std::string,double >::iterator"},
-	 { "map_string_double_t_end", _wrap_map_string_double_t_end, METH_O, "map_string_double_t_end(map_string_double_t self) -> std::map< std::string,double >::iterator"},
-	 { "map_string_double_t_rbegin", _wrap_map_string_double_t_rbegin, METH_O, "map_string_double_t_rbegin(map_string_double_t self) -> std::map< std::string,double >::reverse_iterator"},
-	 { "map_string_double_t_rend", _wrap_map_string_double_t_rend, METH_O, "map_string_double_t_rend(map_string_double_t self) -> std::map< std::string,double >::reverse_iterator"},
-	 { "map_string_double_t_clear", _wrap_map_string_double_t_clear, METH_O, "map_string_double_t_clear(map_string_double_t self)"},
-	 { "map_string_double_t_get_allocator", _wrap_map_string_double_t_get_allocator, METH_O, "map_string_double_t_get_allocator(map_string_double_t self) -> std::map< std::string,double >::allocator_type"},
-	 { "map_string_double_t_count", _wrap_map_string_double_t_count, METH_VARARGS, "map_string_double_t_count(map_string_double_t self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::size_type"},
-	 { "map_string_double_t_erase", _wrap_map_string_double_t_erase, METH_VARARGS, "\n"
-		"map_string_double_t_erase(map_string_double_t self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::size_type\n"
-		"map_string_double_t_erase(map_string_double_t self, std::map< std::string,double >::iterator position)\n"
-		"map_string_double_t_erase(map_string_double_t self, std::map< std::string,double >::iterator first, std::map< std::string,double >::iterator last)\n"
+	 { "map_string_double_T_empty", _wrap_map_string_double_T_empty, METH_O, "map_string_double_T_empty(map_string_double_T self) -> bool"},
+	 { "map_string_double_T_size", _wrap_map_string_double_T_size, METH_O, "map_string_double_T_size(map_string_double_T self) -> std::map< std::string,double >::size_type"},
+	 { "map_string_double_T_swap", _wrap_map_string_double_T_swap, METH_VARARGS, "map_string_double_T_swap(map_string_double_T self, map_string_double_T v)"},
+	 { "map_string_double_T_begin", _wrap_map_string_double_T_begin, METH_O, "map_string_double_T_begin(map_string_double_T self) -> std::map< std::string,double >::iterator"},
+	 { "map_string_double_T_end", _wrap_map_string_double_T_end, METH_O, "map_string_double_T_end(map_string_double_T self) -> std::map< std::string,double >::iterator"},
+	 { "map_string_double_T_rbegin", _wrap_map_string_double_T_rbegin, METH_O, "map_string_double_T_rbegin(map_string_double_T self) -> std::map< std::string,double >::reverse_iterator"},
+	 { "map_string_double_T_rend", _wrap_map_string_double_T_rend, METH_O, "map_string_double_T_rend(map_string_double_T self) -> std::map< std::string,double >::reverse_iterator"},
+	 { "map_string_double_T_clear", _wrap_map_string_double_T_clear, METH_O, "map_string_double_T_clear(map_string_double_T self)"},
+	 { "map_string_double_T_get_allocator", _wrap_map_string_double_T_get_allocator, METH_O, "map_string_double_T_get_allocator(map_string_double_T self) -> std::map< std::string,double >::allocator_type"},
+	 { "map_string_double_T_count", _wrap_map_string_double_T_count, METH_VARARGS, "map_string_double_T_count(map_string_double_T self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::size_type"},
+	 { "map_string_double_T_erase", _wrap_map_string_double_T_erase, METH_VARARGS, "\n"
+		"map_string_double_T_erase(map_string_double_T self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::size_type\n"
+		"map_string_double_T_erase(map_string_double_T self, std::map< std::string,double >::iterator position)\n"
+		"map_string_double_T_erase(map_string_double_T self, std::map< std::string,double >::iterator first, std::map< std::string,double >::iterator last)\n"
 		""},
-	 { "map_string_double_t_find", _wrap_map_string_double_t_find, METH_VARARGS, "map_string_double_t_find(map_string_double_t self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"},
-	 { "map_string_double_t_lower_bound", _wrap_map_string_double_t_lower_bound, METH_VARARGS, "map_string_double_t_lower_bound(map_string_double_t self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"},
-	 { "map_string_double_t_upper_bound", _wrap_map_string_double_t_upper_bound, METH_VARARGS, "map_string_double_t_upper_bound(map_string_double_t self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"},
-	 { "delete_map_string_double_t", _wrap_delete_map_string_double_t, METH_O, "delete_map_string_double_t(map_string_double_t self)"},
-	 { "map_string_double_t_swigregister", map_string_double_t_swigregister, METH_O, NULL},
-	 { "map_string_double_t_swiginit", map_string_double_t_swiginit, METH_VARARGS, NULL},
-	 { "new_pvacuum_double_t", _wrap_new_pvacuum_double_t, METH_VARARGS, "\n"
-		"pvacuum_double_t()\n"
-		"pvacuum_double_t(double first, double second)\n"
-		"new_pvacuum_double_t(pvacuum_double_t other) -> pvacuum_double_t\n"
+	 { "map_string_double_T_find", _wrap_map_string_double_T_find, METH_VARARGS, "map_string_double_T_find(map_string_double_T self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"},
+	 { "map_string_double_T_lower_bound", _wrap_map_string_double_T_lower_bound, METH_VARARGS, "map_string_double_T_lower_bound(map_string_double_T self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"},
+	 { "map_string_double_T_upper_bound", _wrap_map_string_double_T_upper_bound, METH_VARARGS, "map_string_double_T_upper_bound(map_string_double_T self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"},
+	 { "delete_map_string_double_T", _wrap_delete_map_string_double_T, METH_O, "delete_map_string_double_T(map_string_double_T self)"},
+	 { "map_string_double_T_swigregister", map_string_double_T_swigregister, METH_O, NULL},
+	 { "map_string_double_T_swiginit", map_string_double_T_swiginit, METH_VARARGS, NULL},
+	 { "new_pvacuum_double_T", _wrap_new_pvacuum_double_T, METH_VARARGS, "\n"
+		"pvacuum_double_T()\n"
+		"pvacuum_double_T(double first, double second)\n"
+		"new_pvacuum_double_T(pvacuum_double_T other) -> pvacuum_double_T\n"
 		""},
-	 { "pvacuum_double_t_first_set", _wrap_pvacuum_double_t_first_set, METH_VARARGS, "pvacuum_double_t_first_set(pvacuum_double_t self, double first)"},
-	 { "pvacuum_double_t_first_get", _wrap_pvacuum_double_t_first_get, METH_O, "pvacuum_double_t_first_get(pvacuum_double_t self) -> double"},
-	 { "pvacuum_double_t_second_set", _wrap_pvacuum_double_t_second_set, METH_VARARGS, "pvacuum_double_t_second_set(pvacuum_double_t self, double second)"},
-	 { "pvacuum_double_t_second_get", _wrap_pvacuum_double_t_second_get, METH_O, "pvacuum_double_t_second_get(pvacuum_double_t self) -> double"},
-	 { "delete_pvacuum_double_t", _wrap_delete_pvacuum_double_t, METH_O, "delete_pvacuum_double_t(pvacuum_double_t self)"},
-	 { "pvacuum_double_t_swigregister", pvacuum_double_t_swigregister, METH_O, NULL},
-	 { "pvacuum_double_t_swiginit", pvacuum_double_t_swiginit, METH_VARARGS, NULL},
-	 { "vector_pvacuum_double_t_iterator", _wrap_vector_pvacuum_double_t_iterator, METH_O, "vector_pvacuum_double_t_iterator(vector_pvacuum_double_t self) -> SwigPyIterator"},
-	 { "vector_pvacuum_double_t___nonzero__", _wrap_vector_pvacuum_double_t___nonzero__, METH_O, "vector_pvacuum_double_t___nonzero__(vector_pvacuum_double_t self) -> bool"},
-	 { "vector_pvacuum_double_t___bool__", _wrap_vector_pvacuum_double_t___bool__, METH_O, "vector_pvacuum_double_t___bool__(vector_pvacuum_double_t self) -> bool"},
-	 { "vector_pvacuum_double_t___len__", _wrap_vector_pvacuum_double_t___len__, METH_O, "vector_pvacuum_double_t___len__(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::size_type"},
-	 { "vector_pvacuum_double_t___getslice__", _wrap_vector_pvacuum_double_t___getslice__, METH_VARARGS, "vector_pvacuum_double_t___getslice__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j) -> vector_pvacuum_double_t"},
-	 { "vector_pvacuum_double_t___setslice__", _wrap_vector_pvacuum_double_t___setslice__, METH_VARARGS, "\n"
-		"vector_pvacuum_double_t___setslice__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j)\n"
-		"vector_pvacuum_double_t___setslice__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j, vector_pvacuum_double_t v)\n"
+	 { "pvacuum_double_T_first_set", _wrap_pvacuum_double_T_first_set, METH_VARARGS, "pvacuum_double_T_first_set(pvacuum_double_T self, double first)"},
+	 { "pvacuum_double_T_first_get", _wrap_pvacuum_double_T_first_get, METH_O, "pvacuum_double_T_first_get(pvacuum_double_T self) -> double"},
+	 { "pvacuum_double_T_second_set", _wrap_pvacuum_double_T_second_set, METH_VARARGS, "pvacuum_double_T_second_set(pvacuum_double_T self, double second)"},
+	 { "pvacuum_double_T_second_get", _wrap_pvacuum_double_T_second_get, METH_O, "pvacuum_double_T_second_get(pvacuum_double_T self) -> double"},
+	 { "delete_pvacuum_double_T", _wrap_delete_pvacuum_double_T, METH_O, "delete_pvacuum_double_T(pvacuum_double_T self)"},
+	 { "pvacuum_double_T_swigregister", pvacuum_double_T_swigregister, METH_O, NULL},
+	 { "pvacuum_double_T_swiginit", pvacuum_double_T_swiginit, METH_VARARGS, NULL},
+	 { "vector_pvacuum_double_T_iterator", _wrap_vector_pvacuum_double_T_iterator, METH_O, "vector_pvacuum_double_T_iterator(vector_pvacuum_double_T self) -> SwigPyIterator"},
+	 { "vector_pvacuum_double_T___nonzero__", _wrap_vector_pvacuum_double_T___nonzero__, METH_O, "vector_pvacuum_double_T___nonzero__(vector_pvacuum_double_T self) -> bool"},
+	 { "vector_pvacuum_double_T___bool__", _wrap_vector_pvacuum_double_T___bool__, METH_O, "vector_pvacuum_double_T___bool__(vector_pvacuum_double_T self) -> bool"},
+	 { "vector_pvacuum_double_T___len__", _wrap_vector_pvacuum_double_T___len__, METH_O, "vector_pvacuum_double_T___len__(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::size_type"},
+	 { "vector_pvacuum_double_T___getslice__", _wrap_vector_pvacuum_double_T___getslice__, METH_VARARGS, "vector_pvacuum_double_T___getslice__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j) -> vector_pvacuum_double_T"},
+	 { "vector_pvacuum_double_T___setslice__", _wrap_vector_pvacuum_double_T___setslice__, METH_VARARGS, "\n"
+		"vector_pvacuum_double_T___setslice__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j)\n"
+		"vector_pvacuum_double_T___setslice__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j, vector_pvacuum_double_T v)\n"
 		""},
-	 { "vector_pvacuum_double_t___delslice__", _wrap_vector_pvacuum_double_t___delslice__, METH_VARARGS, "vector_pvacuum_double_t___delslice__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j)"},
-	 { "vector_pvacuum_double_t___delitem__", _wrap_vector_pvacuum_double_t___delitem__, METH_VARARGS, "\n"
-		"vector_pvacuum_double_t___delitem__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i)\n"
-		"vector_pvacuum_double_t___delitem__(vector_pvacuum_double_t self, SWIGPY_SLICEOBJECT * slice)\n"
+	 { "vector_pvacuum_double_T___delslice__", _wrap_vector_pvacuum_double_T___delslice__, METH_VARARGS, "vector_pvacuum_double_T___delslice__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j)"},
+	 { "vector_pvacuum_double_T___delitem__", _wrap_vector_pvacuum_double_T___delitem__, METH_VARARGS, "\n"
+		"vector_pvacuum_double_T___delitem__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i)\n"
+		"vector_pvacuum_double_T___delitem__(vector_pvacuum_double_T self, SWIGPY_SLICEOBJECT * slice)\n"
 		""},
-	 { "vector_pvacuum_double_t___getitem__", _wrap_vector_pvacuum_double_t___getitem__, METH_VARARGS, "\n"
-		"vector_pvacuum_double_t___getitem__(vector_pvacuum_double_t self, SWIGPY_SLICEOBJECT * slice) -> vector_pvacuum_double_t\n"
-		"vector_pvacuum_double_t___getitem__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i) -> pvacuum_double_t\n"
+	 { "vector_pvacuum_double_T___getitem__", _wrap_vector_pvacuum_double_T___getitem__, METH_VARARGS, "\n"
+		"vector_pvacuum_double_T___getitem__(vector_pvacuum_double_T self, SWIGPY_SLICEOBJECT * slice) -> vector_pvacuum_double_T\n"
+		"vector_pvacuum_double_T___getitem__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i) -> pvacuum_double_T\n"
 		""},
-	 { "vector_pvacuum_double_t___setitem__", _wrap_vector_pvacuum_double_t___setitem__, METH_VARARGS, "\n"
-		"vector_pvacuum_double_t___setitem__(vector_pvacuum_double_t self, SWIGPY_SLICEOBJECT * slice, vector_pvacuum_double_t v)\n"
-		"vector_pvacuum_double_t___setitem__(vector_pvacuum_double_t self, SWIGPY_SLICEOBJECT * slice)\n"
-		"vector_pvacuum_double_t___setitem__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i, pvacuum_double_t x)\n"
+	 { "vector_pvacuum_double_T___setitem__", _wrap_vector_pvacuum_double_T___setitem__, METH_VARARGS, "\n"
+		"vector_pvacuum_double_T___setitem__(vector_pvacuum_double_T self, SWIGPY_SLICEOBJECT * slice, vector_pvacuum_double_T v)\n"
+		"vector_pvacuum_double_T___setitem__(vector_pvacuum_double_T self, SWIGPY_SLICEOBJECT * slice)\n"
+		"vector_pvacuum_double_T___setitem__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i, pvacuum_double_T x)\n"
 		""},
-	 { "vector_pvacuum_double_t_pop", _wrap_vector_pvacuum_double_t_pop, METH_O, "vector_pvacuum_double_t_pop(vector_pvacuum_double_t self) -> pvacuum_double_t"},
-	 { "vector_pvacuum_double_t_append", _wrap_vector_pvacuum_double_t_append, METH_VARARGS, "vector_pvacuum_double_t_append(vector_pvacuum_double_t self, pvacuum_double_t x)"},
-	 { "vector_pvacuum_double_t_empty", _wrap_vector_pvacuum_double_t_empty, METH_O, "vector_pvacuum_double_t_empty(vector_pvacuum_double_t self) -> bool"},
-	 { "vector_pvacuum_double_t_size", _wrap_vector_pvacuum_double_t_size, METH_O, "vector_pvacuum_double_t_size(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::size_type"},
-	 { "vector_pvacuum_double_t_swap", _wrap_vector_pvacuum_double_t_swap, METH_VARARGS, "vector_pvacuum_double_t_swap(vector_pvacuum_double_t self, vector_pvacuum_double_t v)"},
-	 { "vector_pvacuum_double_t_begin", _wrap_vector_pvacuum_double_t_begin, METH_O, "vector_pvacuum_double_t_begin(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::iterator"},
-	 { "vector_pvacuum_double_t_end", _wrap_vector_pvacuum_double_t_end, METH_O, "vector_pvacuum_double_t_end(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::iterator"},
-	 { "vector_pvacuum_double_t_rbegin", _wrap_vector_pvacuum_double_t_rbegin, METH_O, "vector_pvacuum_double_t_rbegin(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::reverse_iterator"},
-	 { "vector_pvacuum_double_t_rend", _wrap_vector_pvacuum_double_t_rend, METH_O, "vector_pvacuum_double_t_rend(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::reverse_iterator"},
-	 { "vector_pvacuum_double_t_clear", _wrap_vector_pvacuum_double_t_clear, METH_O, "vector_pvacuum_double_t_clear(vector_pvacuum_double_t self)"},
-	 { "vector_pvacuum_double_t_get_allocator", _wrap_vector_pvacuum_double_t_get_allocator, METH_O, "vector_pvacuum_double_t_get_allocator(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::allocator_type"},
-	 { "vector_pvacuum_double_t_pop_back", _wrap_vector_pvacuum_double_t_pop_back, METH_O, "vector_pvacuum_double_t_pop_back(vector_pvacuum_double_t self)"},
-	 { "vector_pvacuum_double_t_erase", _wrap_vector_pvacuum_double_t_erase, METH_VARARGS, "\n"
-		"vector_pvacuum_double_t_erase(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::iterator pos) -> std::vector< std::pair< double,double > >::iterator\n"
-		"vector_pvacuum_double_t_erase(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::iterator first, std::vector< std::pair< double,double > >::iterator last) -> std::vector< std::pair< double,double > >::iterator\n"
+	 { "vector_pvacuum_double_T_pop", _wrap_vector_pvacuum_double_T_pop, METH_O, "vector_pvacuum_double_T_pop(vector_pvacuum_double_T self) -> pvacuum_double_T"},
+	 { "vector_pvacuum_double_T_append", _wrap_vector_pvacuum_double_T_append, METH_VARARGS, "vector_pvacuum_double_T_append(vector_pvacuum_double_T self, pvacuum_double_T x)"},
+	 { "vector_pvacuum_double_T_empty", _wrap_vector_pvacuum_double_T_empty, METH_O, "vector_pvacuum_double_T_empty(vector_pvacuum_double_T self) -> bool"},
+	 { "vector_pvacuum_double_T_size", _wrap_vector_pvacuum_double_T_size, METH_O, "vector_pvacuum_double_T_size(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::size_type"},
+	 { "vector_pvacuum_double_T_swap", _wrap_vector_pvacuum_double_T_swap, METH_VARARGS, "vector_pvacuum_double_T_swap(vector_pvacuum_double_T self, vector_pvacuum_double_T v)"},
+	 { "vector_pvacuum_double_T_begin", _wrap_vector_pvacuum_double_T_begin, METH_O, "vector_pvacuum_double_T_begin(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::iterator"},
+	 { "vector_pvacuum_double_T_end", _wrap_vector_pvacuum_double_T_end, METH_O, "vector_pvacuum_double_T_end(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::iterator"},
+	 { "vector_pvacuum_double_T_rbegin", _wrap_vector_pvacuum_double_T_rbegin, METH_O, "vector_pvacuum_double_T_rbegin(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::reverse_iterator"},
+	 { "vector_pvacuum_double_T_rend", _wrap_vector_pvacuum_double_T_rend, METH_O, "vector_pvacuum_double_T_rend(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::reverse_iterator"},
+	 { "vector_pvacuum_double_T_clear", _wrap_vector_pvacuum_double_T_clear, METH_O, "vector_pvacuum_double_T_clear(vector_pvacuum_double_T self)"},
+	 { "vector_pvacuum_double_T_get_allocator", _wrap_vector_pvacuum_double_T_get_allocator, METH_O, "vector_pvacuum_double_T_get_allocator(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::allocator_type"},
+	 { "vector_pvacuum_double_T_pop_back", _wrap_vector_pvacuum_double_T_pop_back, METH_O, "vector_pvacuum_double_T_pop_back(vector_pvacuum_double_T self)"},
+	 { "vector_pvacuum_double_T_erase", _wrap_vector_pvacuum_double_T_erase, METH_VARARGS, "\n"
+		"vector_pvacuum_double_T_erase(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::iterator pos) -> std::vector< std::pair< double,double > >::iterator\n"
+		"vector_pvacuum_double_T_erase(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::iterator first, std::vector< std::pair< double,double > >::iterator last) -> std::vector< std::pair< double,double > >::iterator\n"
 		""},
-	 { "new_vector_pvacuum_double_t", _wrap_new_vector_pvacuum_double_t, METH_VARARGS, "\n"
-		"vector_pvacuum_double_t()\n"
-		"vector_pvacuum_double_t(vector_pvacuum_double_t other)\n"
-		"vector_pvacuum_double_t(std::vector< std::pair< double,double > >::size_type size)\n"
-		"new_vector_pvacuum_double_t(std::vector< std::pair< double,double > >::size_type size, pvacuum_double_t value) -> vector_pvacuum_double_t\n"
+	 { "new_vector_pvacuum_double_T", _wrap_new_vector_pvacuum_double_T, METH_VARARGS, "\n"
+		"vector_pvacuum_double_T()\n"
+		"vector_pvacuum_double_T(vector_pvacuum_double_T other)\n"
+		"vector_pvacuum_double_T(std::vector< std::pair< double,double > >::size_type size)\n"
+		"new_vector_pvacuum_double_T(std::vector< std::pair< double,double > >::size_type size, pvacuum_double_T value) -> vector_pvacuum_double_T\n"
 		""},
-	 { "vector_pvacuum_double_t_push_back", _wrap_vector_pvacuum_double_t_push_back, METH_VARARGS, "vector_pvacuum_double_t_push_back(vector_pvacuum_double_t self, pvacuum_double_t x)"},
-	 { "vector_pvacuum_double_t_front", _wrap_vector_pvacuum_double_t_front, METH_O, "vector_pvacuum_double_t_front(vector_pvacuum_double_t self) -> pvacuum_double_t"},
-	 { "vector_pvacuum_double_t_back", _wrap_vector_pvacuum_double_t_back, METH_O, "vector_pvacuum_double_t_back(vector_pvacuum_double_t self) -> pvacuum_double_t"},
-	 { "vector_pvacuum_double_t_assign", _wrap_vector_pvacuum_double_t_assign, METH_VARARGS, "vector_pvacuum_double_t_assign(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::size_type n, pvacuum_double_t x)"},
-	 { "vector_pvacuum_double_t_resize", _wrap_vector_pvacuum_double_t_resize, METH_VARARGS, "\n"
-		"vector_pvacuum_double_t_resize(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::size_type new_size)\n"
-		"vector_pvacuum_double_t_resize(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::size_type new_size, pvacuum_double_t x)\n"
+	 { "vector_pvacuum_double_T_push_back", _wrap_vector_pvacuum_double_T_push_back, METH_VARARGS, "vector_pvacuum_double_T_push_back(vector_pvacuum_double_T self, pvacuum_double_T x)"},
+	 { "vector_pvacuum_double_T_front", _wrap_vector_pvacuum_double_T_front, METH_O, "vector_pvacuum_double_T_front(vector_pvacuum_double_T self) -> pvacuum_double_T"},
+	 { "vector_pvacuum_double_T_back", _wrap_vector_pvacuum_double_T_back, METH_O, "vector_pvacuum_double_T_back(vector_pvacuum_double_T self) -> pvacuum_double_T"},
+	 { "vector_pvacuum_double_T_assign", _wrap_vector_pvacuum_double_T_assign, METH_VARARGS, "vector_pvacuum_double_T_assign(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::size_type n, pvacuum_double_T x)"},
+	 { "vector_pvacuum_double_T_resize", _wrap_vector_pvacuum_double_T_resize, METH_VARARGS, "\n"
+		"vector_pvacuum_double_T_resize(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::size_type new_size)\n"
+		"vector_pvacuum_double_T_resize(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::size_type new_size, pvacuum_double_T x)\n"
 		""},
-	 { "vector_pvacuum_double_t_insert", _wrap_vector_pvacuum_double_t_insert, METH_VARARGS, "\n"
-		"vector_pvacuum_double_t_insert(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::iterator pos, pvacuum_double_t x) -> std::vector< std::pair< double,double > >::iterator\n"
-		"vector_pvacuum_double_t_insert(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::iterator pos, std::vector< std::pair< double,double > >::size_type n, pvacuum_double_t x)\n"
+	 { "vector_pvacuum_double_T_insert", _wrap_vector_pvacuum_double_T_insert, METH_VARARGS, "\n"
+		"vector_pvacuum_double_T_insert(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::iterator pos, pvacuum_double_T x) -> std::vector< std::pair< double,double > >::iterator\n"
+		"vector_pvacuum_double_T_insert(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::iterator pos, std::vector< std::pair< double,double > >::size_type n, pvacuum_double_T x)\n"
 		""},
-	 { "vector_pvacuum_double_t_reserve", _wrap_vector_pvacuum_double_t_reserve, METH_VARARGS, "vector_pvacuum_double_t_reserve(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::size_type n)"},
-	 { "vector_pvacuum_double_t_capacity", _wrap_vector_pvacuum_double_t_capacity, METH_O, "vector_pvacuum_double_t_capacity(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::size_type"},
-	 { "delete_vector_pvacuum_double_t", _wrap_delete_vector_pvacuum_double_t, METH_O, "delete_vector_pvacuum_double_t(vector_pvacuum_double_t self)"},
-	 { "vector_pvacuum_double_t_swigregister", vector_pvacuum_double_t_swigregister, METH_O, NULL},
-	 { "vector_pvacuum_double_t_swiginit", vector_pvacuum_double_t_swiginit, METH_VARARGS, NULL},
+	 { "vector_pvacuum_double_T_reserve", _wrap_vector_pvacuum_double_T_reserve, METH_VARARGS, "vector_pvacuum_double_T_reserve(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::size_type n)"},
+	 { "vector_pvacuum_double_T_capacity", _wrap_vector_pvacuum_double_T_capacity, METH_O, "vector_pvacuum_double_T_capacity(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::size_type"},
+	 { "delete_vector_pvacuum_double_T", _wrap_delete_vector_pvacuum_double_T, METH_O, "delete_vector_pvacuum_double_T(vector_pvacuum_double_T self)"},
+	 { "vector_pvacuum_double_T_swigregister", vector_pvacuum_double_T_swigregister, METH_O, NULL},
+	 { "vector_pvacuum_double_T_swiginit", vector_pvacuum_double_T_swiginit, METH_VARARGS, NULL},
 	 { "mul_I", _wrap_mul_I, METH_O, "mul_I(complex_t z) -> complex_t"},
 	 { "exp_I", _wrap_exp_I, METH_O, "exp_I(complex_t z) -> complex_t"},
 	 { "isfinite", _wrap_isfinite, METH_O, "isfinite(complex_t z) -> bool"},
@@ -30564,7 +30564,7 @@ static PyMethodDef SwigMethods[] = {
 	 { "Span_low", _wrap_Span_low, METH_O, "Span_low(Span self) -> double"},
 	 { "Span_hig", _wrap_Span_hig, METH_O, "Span_hig(Span self) -> double"},
 	 { "Span_contains", _wrap_Span_contains, METH_VARARGS, "Span_contains(Span self, double z) -> bool"},
-	 { "Span_pair", _wrap_Span_pair, METH_O, "Span_pair(Span self) -> pvacuum_double_t"},
+	 { "Span_pair", _wrap_Span_pair, METH_O, "Span_pair(Span self) -> pvacuum_double_T"},
 	 { "Span_unite", _wrap_Span_unite, METH_VARARGS, "Span_unite(Span left, Span right) -> Span"},
 	 { "delete_Span", _wrap_delete_Span, METH_O, "delete_Span(Span self)"},
 	 { "Span_swigregister", Span_swigregister, METH_O, NULL},
@@ -30586,21 +30586,21 @@ static PyMethodDef SwigMethods[] = {
 	 { "Scale_size", _wrap_Scale_size, METH_O, "Scale_size(Scale self) -> size_t"},
 	 { "Scale_min", _wrap_Scale_min, METH_O, "Scale_min(Scale self) -> double"},
 	 { "Scale_max", _wrap_Scale_max, METH_O, "Scale_max(Scale self) -> double"},
-	 { "Scale_bounds", _wrap_Scale_bounds, METH_O, "Scale_bounds(Scale self) -> pvacuum_double_t"},
+	 { "Scale_bounds", _wrap_Scale_bounds, METH_O, "Scale_bounds(Scale self) -> pvacuum_double_T"},
 	 { "Scale_rangeComprises", _wrap_Scale_rangeComprises, METH_VARARGS, "Scale_rangeComprises(Scale self, double value) -> bool"},
 	 { "Scale_span", _wrap_Scale_span, METH_O, "Scale_span(Scale self) -> double"},
 	 { "Scale_center", _wrap_Scale_center, METH_O, "Scale_center(Scale self) -> double"},
 	 { "Scale_bin", _wrap_Scale_bin, METH_VARARGS, "Scale_bin(Scale self, size_t i) -> Bin1D const &"},
 	 { "Scale_binCenter", _wrap_Scale_binCenter, METH_VARARGS, "Scale_binCenter(Scale self, size_t i) -> double"},
 	 { "Scale_bins", _wrap_Scale_bins, METH_O, "Scale_bins(Scale self) -> std::vector< Bin1D,std::allocator< Bin1D > > const &"},
-	 { "Scale_binCenters", _wrap_Scale_binCenters, METH_O, "Scale_binCenters(Scale self) -> vdouble1d_t"},
+	 { "Scale_binCenters", _wrap_Scale_binCenters, METH_O, "Scale_binCenters(Scale self) -> vdouble1d_T"},
 	 { "Scale_closestIndex", _wrap_Scale_closestIndex, METH_VARARGS, "Scale_closestIndex(Scale self, double value) -> size_t"},
 	 { "Scale_isEquiDivision", _wrap_Scale_isEquiDivision, METH_O, "Scale_isEquiDivision(Scale self) -> bool"},
 	 { "Scale_isEquiScan", _wrap_Scale_isEquiScan, METH_O, "Scale_isEquiScan(Scale self) -> bool"},
 	 { "Scale_isScan", _wrap_Scale_isScan, METH_O, "Scale_isScan(Scale self) -> bool"},
 	 { "Scale_clipped", _wrap_Scale_clipped, METH_VARARGS, "\n"
 		"Scale_clipped(Scale self, double lower, double upper) -> Scale\n"
-		"Scale_clipped(Scale self, pvacuum_double_t bounds) -> Scale\n"
+		"Scale_clipped(Scale self, pvacuum_double_T bounds) -> Scale\n"
 		""},
 	 { "Scale___eq__", _wrap_Scale___eq__, METH_VARARGS, "Scale___eq__(Scale self, Scale other) -> bool"},
 	 { "Scale_coordName", _wrap_Scale_coordName, METH_O, "Scale_coordName(Scale self) -> std::string"},
@@ -30614,8 +30614,8 @@ static PyMethodDef SwigMethods[] = {
 	 { "delete_Scale", _wrap_delete_Scale, METH_O, "delete_Scale(Scale self)"},
 	 { "Scale_swigregister", Scale_swigregister, METH_O, NULL},
 	 { "Scale_swiginit", Scale_swiginit, METH_VARARGS, NULL},
-	 { "GenericScale", _wrap_GenericScale, METH_VARARGS, "GenericScale(std::string name, vdouble1d_t limits) -> Scale"},
-	 { "ListScan", _wrap_ListScan, METH_VARARGS, "ListScan(std::string name, vdouble1d_t points) -> Scale"},
+	 { "GenericScale", _wrap_GenericScale, METH_VARARGS, "GenericScale(std::string name, vdouble1d_T limits) -> Scale"},
+	 { "ListScan", _wrap_ListScan, METH_VARARGS, "ListScan(std::string name, vdouble1d_T points) -> Scale"},
 	 { "EquiDivision", _wrap_EquiDivision, METH_VARARGS, "EquiDivision(std::string name, size_t N, double start, double end) -> Scale"},
 	 { "EquiScan", _wrap_EquiScan, METH_VARARGS, "EquiScan(std::string name, size_t N, double start, double end) -> Scale"},
 	 { "new_Frame", _wrap_new_Frame, METH_VARARGS, "\n"
@@ -30634,7 +30634,7 @@ static PyMethodDef SwigMethods[] = {
 	 { "Frame_yAxis", _wrap_Frame_yAxis, METH_O, "Frame_yAxis(Frame self) -> Scale"},
 	 { "Frame_projectedCoord", _wrap_Frame_projectedCoord, METH_VARARGS, "Frame_projectedCoord(Frame self, size_t i_flat, size_t k_axis) -> double"},
 	 { "Frame_projectedBin", _wrap_Frame_projectedBin, METH_VARARGS, "Frame_projectedBin(Frame self, size_t i_flat, size_t k_axis) -> Bin1D const &"},
-	 { "Frame_allIndices", _wrap_Frame_allIndices, METH_VARARGS, "Frame_allIndices(Frame self, size_t i_flat) -> vector_integer_t"},
+	 { "Frame_allIndices", _wrap_Frame_allIndices, METH_VARARGS, "Frame_allIndices(Frame self, size_t i_flat) -> vector_integer_T"},
 	 { "Frame_projectedIndex", _wrap_Frame_projectedIndex, METH_VARARGS, "Frame_projectedIndex(Frame self, size_t i, size_t k_axis) -> size_t"},
 	 { "Frame_hasSameSizes", _wrap_Frame_hasSameSizes, METH_VARARGS, "Frame_hasSameSizes(Frame self, Frame arg2) -> bool"},
 	 { "Frame___eq__", _wrap_Frame___eq__, METH_VARARGS, "Frame___eq__(Frame self, Frame arg2) -> bool"},
diff --git a/auto/Wrap/libBornAgainDevice.py b/auto/Wrap/libBornAgainDevice.py
index e2a577d678854ad82a192cb2745216b1386fb4b4..380dc6ec0e96f279830075f018ab481ed36d16c7 100644
--- a/auto/Wrap/libBornAgainDevice.py
+++ b/auto/Wrap/libBornAgainDevice.py
@@ -153,1191 +153,1191 @@ def deprecated(message):
       return deprecated_func
   return deprecated_decorator
 
-class vdouble1d_t(object):
+class vdouble1d_T(object):
     r"""Proxy of C++ std::vector< double > class."""
 
     thisown = property(lambda x: x.this.own(), lambda x, v: x.this.own(v), doc="The membership flag")
     __repr__ = _swig_repr
 
     def iterator(self):
-        r"""iterator(vdouble1d_t self) -> SwigPyIterator"""
-        return _libBornAgainDevice.vdouble1d_t_iterator(self)
+        r"""iterator(vdouble1d_T self) -> SwigPyIterator"""
+        return _libBornAgainDevice.vdouble1d_T_iterator(self)
     def __iter__(self):
         return self.iterator()
 
     def __nonzero__(self):
-        r"""__nonzero__(vdouble1d_t self) -> bool"""
-        return _libBornAgainDevice.vdouble1d_t___nonzero__(self)
+        r"""__nonzero__(vdouble1d_T self) -> bool"""
+        return _libBornAgainDevice.vdouble1d_T___nonzero__(self)
 
     def __bool__(self):
-        r"""__bool__(vdouble1d_t self) -> bool"""
-        return _libBornAgainDevice.vdouble1d_t___bool__(self)
+        r"""__bool__(vdouble1d_T self) -> bool"""
+        return _libBornAgainDevice.vdouble1d_T___bool__(self)
 
     def __len__(self):
-        r"""__len__(vdouble1d_t self) -> std::vector< double >::size_type"""
-        return _libBornAgainDevice.vdouble1d_t___len__(self)
+        r"""__len__(vdouble1d_T self) -> std::vector< double >::size_type"""
+        return _libBornAgainDevice.vdouble1d_T___len__(self)
 
     def __getslice__(self, i, j):
-        r"""__getslice__(vdouble1d_t self, std::vector< double >::difference_type i, std::vector< double >::difference_type j) -> vdouble1d_t"""
-        return _libBornAgainDevice.vdouble1d_t___getslice__(self, i, j)
+        r"""__getslice__(vdouble1d_T self, std::vector< double >::difference_type i, std::vector< double >::difference_type j) -> vdouble1d_T"""
+        return _libBornAgainDevice.vdouble1d_T___getslice__(self, i, j)
 
     def __setslice__(self, *args):
         r"""
-        __setslice__(vdouble1d_t self, std::vector< double >::difference_type i, std::vector< double >::difference_type j)
-        __setslice__(vdouble1d_t self, std::vector< double >::difference_type i, std::vector< double >::difference_type j, vdouble1d_t v)
+        __setslice__(vdouble1d_T self, std::vector< double >::difference_type i, std::vector< double >::difference_type j)
+        __setslice__(vdouble1d_T self, std::vector< double >::difference_type i, std::vector< double >::difference_type j, vdouble1d_T v)
         """
-        return _libBornAgainDevice.vdouble1d_t___setslice__(self, *args)
+        return _libBornAgainDevice.vdouble1d_T___setslice__(self, *args)
 
     def __delslice__(self, i, j):
-        r"""__delslice__(vdouble1d_t self, std::vector< double >::difference_type i, std::vector< double >::difference_type j)"""
-        return _libBornAgainDevice.vdouble1d_t___delslice__(self, i, j)
+        r"""__delslice__(vdouble1d_T self, std::vector< double >::difference_type i, std::vector< double >::difference_type j)"""
+        return _libBornAgainDevice.vdouble1d_T___delslice__(self, i, j)
 
     def __delitem__(self, *args):
         r"""
-        __delitem__(vdouble1d_t self, std::vector< double >::difference_type i)
-        __delitem__(vdouble1d_t self, SWIGPY_SLICEOBJECT * slice)
+        __delitem__(vdouble1d_T self, std::vector< double >::difference_type i)
+        __delitem__(vdouble1d_T self, SWIGPY_SLICEOBJECT * slice)
         """
-        return _libBornAgainDevice.vdouble1d_t___delitem__(self, *args)
+        return _libBornAgainDevice.vdouble1d_T___delitem__(self, *args)
 
     def __getitem__(self, *args):
         r"""
-        __getitem__(vdouble1d_t self, SWIGPY_SLICEOBJECT * slice) -> vdouble1d_t
-        __getitem__(vdouble1d_t self, std::vector< double >::difference_type i) -> std::vector< double >::value_type const &
+        __getitem__(vdouble1d_T self, SWIGPY_SLICEOBJECT * slice) -> vdouble1d_T
+        __getitem__(vdouble1d_T self, std::vector< double >::difference_type i) -> std::vector< double >::value_type const &
         """
-        return _libBornAgainDevice.vdouble1d_t___getitem__(self, *args)
+        return _libBornAgainDevice.vdouble1d_T___getitem__(self, *args)
 
     def __setitem__(self, *args):
         r"""
-        __setitem__(vdouble1d_t self, SWIGPY_SLICEOBJECT * slice, vdouble1d_t v)
-        __setitem__(vdouble1d_t self, SWIGPY_SLICEOBJECT * slice)
-        __setitem__(vdouble1d_t self, std::vector< double >::difference_type i, std::vector< double >::value_type const & x)
+        __setitem__(vdouble1d_T self, SWIGPY_SLICEOBJECT * slice, vdouble1d_T v)
+        __setitem__(vdouble1d_T self, SWIGPY_SLICEOBJECT * slice)
+        __setitem__(vdouble1d_T self, std::vector< double >::difference_type i, std::vector< double >::value_type const & x)
         """
-        return _libBornAgainDevice.vdouble1d_t___setitem__(self, *args)
+        return _libBornAgainDevice.vdouble1d_T___setitem__(self, *args)
 
     def pop(self):
-        r"""pop(vdouble1d_t self) -> std::vector< double >::value_type"""
-        return _libBornAgainDevice.vdouble1d_t_pop(self)
+        r"""pop(vdouble1d_T self) -> std::vector< double >::value_type"""
+        return _libBornAgainDevice.vdouble1d_T_pop(self)
 
     def append(self, x):
-        r"""append(vdouble1d_t self, std::vector< double >::value_type const & x)"""
-        return _libBornAgainDevice.vdouble1d_t_append(self, x)
+        r"""append(vdouble1d_T self, std::vector< double >::value_type const & x)"""
+        return _libBornAgainDevice.vdouble1d_T_append(self, x)
 
     def empty(self):
-        r"""empty(vdouble1d_t self) -> bool"""
-        return _libBornAgainDevice.vdouble1d_t_empty(self)
+        r"""empty(vdouble1d_T self) -> bool"""
+        return _libBornAgainDevice.vdouble1d_T_empty(self)
 
     def size(self):
-        r"""size(vdouble1d_t self) -> std::vector< double >::size_type"""
-        return _libBornAgainDevice.vdouble1d_t_size(self)
+        r"""size(vdouble1d_T self) -> std::vector< double >::size_type"""
+        return _libBornAgainDevice.vdouble1d_T_size(self)
 
     def swap(self, v):
-        r"""swap(vdouble1d_t self, vdouble1d_t v)"""
-        return _libBornAgainDevice.vdouble1d_t_swap(self, v)
+        r"""swap(vdouble1d_T self, vdouble1d_T v)"""
+        return _libBornAgainDevice.vdouble1d_T_swap(self, v)
 
     def begin(self):
-        r"""begin(vdouble1d_t self) -> std::vector< double >::iterator"""
-        return _libBornAgainDevice.vdouble1d_t_begin(self)
+        r"""begin(vdouble1d_T self) -> std::vector< double >::iterator"""
+        return _libBornAgainDevice.vdouble1d_T_begin(self)
 
     def end(self):
-        r"""end(vdouble1d_t self) -> std::vector< double >::iterator"""
-        return _libBornAgainDevice.vdouble1d_t_end(self)
+        r"""end(vdouble1d_T self) -> std::vector< double >::iterator"""
+        return _libBornAgainDevice.vdouble1d_T_end(self)
 
     def rbegin(self):
-        r"""rbegin(vdouble1d_t self) -> std::vector< double >::reverse_iterator"""
-        return _libBornAgainDevice.vdouble1d_t_rbegin(self)
+        r"""rbegin(vdouble1d_T self) -> std::vector< double >::reverse_iterator"""
+        return _libBornAgainDevice.vdouble1d_T_rbegin(self)
 
     def rend(self):
-        r"""rend(vdouble1d_t self) -> std::vector< double >::reverse_iterator"""
-        return _libBornAgainDevice.vdouble1d_t_rend(self)
+        r"""rend(vdouble1d_T self) -> std::vector< double >::reverse_iterator"""
+        return _libBornAgainDevice.vdouble1d_T_rend(self)
 
     def clear(self):
-        r"""clear(vdouble1d_t self)"""
-        return _libBornAgainDevice.vdouble1d_t_clear(self)
+        r"""clear(vdouble1d_T self)"""
+        return _libBornAgainDevice.vdouble1d_T_clear(self)
 
     def get_allocator(self):
-        r"""get_allocator(vdouble1d_t self) -> std::vector< double >::allocator_type"""
-        return _libBornAgainDevice.vdouble1d_t_get_allocator(self)
+        r"""get_allocator(vdouble1d_T self) -> std::vector< double >::allocator_type"""
+        return _libBornAgainDevice.vdouble1d_T_get_allocator(self)
 
     def pop_back(self):
-        r"""pop_back(vdouble1d_t self)"""
-        return _libBornAgainDevice.vdouble1d_t_pop_back(self)
+        r"""pop_back(vdouble1d_T self)"""
+        return _libBornAgainDevice.vdouble1d_T_pop_back(self)
 
     def erase(self, *args):
         r"""
-        erase(vdouble1d_t self, std::vector< double >::iterator pos) -> std::vector< double >::iterator
-        erase(vdouble1d_t self, std::vector< double >::iterator first, std::vector< double >::iterator last) -> std::vector< double >::iterator
+        erase(vdouble1d_T self, std::vector< double >::iterator pos) -> std::vector< double >::iterator
+        erase(vdouble1d_T self, std::vector< double >::iterator first, std::vector< double >::iterator last) -> std::vector< double >::iterator
         """
-        return _libBornAgainDevice.vdouble1d_t_erase(self, *args)
+        return _libBornAgainDevice.vdouble1d_T_erase(self, *args)
 
     def __init__(self, *args):
         r"""
-        __init__(vdouble1d_t self) -> vdouble1d_t
-        __init__(vdouble1d_t self, vdouble1d_t other) -> vdouble1d_t
-        __init__(vdouble1d_t self, std::vector< double >::size_type size) -> vdouble1d_t
-        __init__(vdouble1d_t self, std::vector< double >::size_type size, std::vector< double >::value_type const & value) -> vdouble1d_t
+        __init__(vdouble1d_T self) -> vdouble1d_T
+        __init__(vdouble1d_T self, vdouble1d_T other) -> vdouble1d_T
+        __init__(vdouble1d_T self, std::vector< double >::size_type size) -> vdouble1d_T
+        __init__(vdouble1d_T self, std::vector< double >::size_type size, std::vector< double >::value_type const & value) -> vdouble1d_T
         """
-        _libBornAgainDevice.vdouble1d_t_swiginit(self, _libBornAgainDevice.new_vdouble1d_t(*args))
+        _libBornAgainDevice.vdouble1d_T_swiginit(self, _libBornAgainDevice.new_vdouble1d_T(*args))
 
     def push_back(self, x):
-        r"""push_back(vdouble1d_t self, std::vector< double >::value_type const & x)"""
-        return _libBornAgainDevice.vdouble1d_t_push_back(self, x)
+        r"""push_back(vdouble1d_T self, std::vector< double >::value_type const & x)"""
+        return _libBornAgainDevice.vdouble1d_T_push_back(self, x)
 
     def front(self):
-        r"""front(vdouble1d_t self) -> std::vector< double >::value_type const &"""
-        return _libBornAgainDevice.vdouble1d_t_front(self)
+        r"""front(vdouble1d_T self) -> std::vector< double >::value_type const &"""
+        return _libBornAgainDevice.vdouble1d_T_front(self)
 
     def back(self):
-        r"""back(vdouble1d_t self) -> std::vector< double >::value_type const &"""
-        return _libBornAgainDevice.vdouble1d_t_back(self)
+        r"""back(vdouble1d_T self) -> std::vector< double >::value_type const &"""
+        return _libBornAgainDevice.vdouble1d_T_back(self)
 
     def assign(self, n, x):
-        r"""assign(vdouble1d_t self, std::vector< double >::size_type n, std::vector< double >::value_type const & x)"""
-        return _libBornAgainDevice.vdouble1d_t_assign(self, n, x)
+        r"""assign(vdouble1d_T self, std::vector< double >::size_type n, std::vector< double >::value_type const & x)"""
+        return _libBornAgainDevice.vdouble1d_T_assign(self, n, x)
 
     def resize(self, *args):
         r"""
-        resize(vdouble1d_t self, std::vector< double >::size_type new_size)
-        resize(vdouble1d_t self, std::vector< double >::size_type new_size, std::vector< double >::value_type const & x)
+        resize(vdouble1d_T self, std::vector< double >::size_type new_size)
+        resize(vdouble1d_T self, std::vector< double >::size_type new_size, std::vector< double >::value_type const & x)
         """
-        return _libBornAgainDevice.vdouble1d_t_resize(self, *args)
+        return _libBornAgainDevice.vdouble1d_T_resize(self, *args)
 
     def insert(self, *args):
         r"""
-        insert(vdouble1d_t self, std::vector< double >::iterator pos, std::vector< double >::value_type const & x) -> std::vector< double >::iterator
-        insert(vdouble1d_t self, std::vector< double >::iterator pos, std::vector< double >::size_type n, std::vector< double >::value_type const & x)
+        insert(vdouble1d_T self, std::vector< double >::iterator pos, std::vector< double >::value_type const & x) -> std::vector< double >::iterator
+        insert(vdouble1d_T self, std::vector< double >::iterator pos, std::vector< double >::size_type n, std::vector< double >::value_type const & x)
         """
-        return _libBornAgainDevice.vdouble1d_t_insert(self, *args)
+        return _libBornAgainDevice.vdouble1d_T_insert(self, *args)
 
     def reserve(self, n):
-        r"""reserve(vdouble1d_t self, std::vector< double >::size_type n)"""
-        return _libBornAgainDevice.vdouble1d_t_reserve(self, n)
+        r"""reserve(vdouble1d_T self, std::vector< double >::size_type n)"""
+        return _libBornAgainDevice.vdouble1d_T_reserve(self, n)
 
     def capacity(self):
-        r"""capacity(vdouble1d_t self) -> std::vector< double >::size_type"""
-        return _libBornAgainDevice.vdouble1d_t_capacity(self)
-    __swig_destroy__ = _libBornAgainDevice.delete_vdouble1d_t
+        r"""capacity(vdouble1d_T self) -> std::vector< double >::size_type"""
+        return _libBornAgainDevice.vdouble1d_T_capacity(self)
+    __swig_destroy__ = _libBornAgainDevice.delete_vdouble1d_T
 
-# Register vdouble1d_t in _libBornAgainDevice:
-_libBornAgainDevice.vdouble1d_t_swigregister(vdouble1d_t)
-class vdouble2d_t(object):
+# Register vdouble1d_T in _libBornAgainDevice:
+_libBornAgainDevice.vdouble1d_T_swigregister(vdouble1d_T)
+class vdouble2d_T(object):
     r"""Proxy of C++ std::vector< std::vector< double > > class."""
 
     thisown = property(lambda x: x.this.own(), lambda x, v: x.this.own(v), doc="The membership flag")
     __repr__ = _swig_repr
 
     def iterator(self):
-        r"""iterator(vdouble2d_t self) -> SwigPyIterator"""
-        return _libBornAgainDevice.vdouble2d_t_iterator(self)
+        r"""iterator(vdouble2d_T self) -> SwigPyIterator"""
+        return _libBornAgainDevice.vdouble2d_T_iterator(self)
     def __iter__(self):
         return self.iterator()
 
     def __nonzero__(self):
-        r"""__nonzero__(vdouble2d_t self) -> bool"""
-        return _libBornAgainDevice.vdouble2d_t___nonzero__(self)
+        r"""__nonzero__(vdouble2d_T self) -> bool"""
+        return _libBornAgainDevice.vdouble2d_T___nonzero__(self)
 
     def __bool__(self):
-        r"""__bool__(vdouble2d_t self) -> bool"""
-        return _libBornAgainDevice.vdouble2d_t___bool__(self)
+        r"""__bool__(vdouble2d_T self) -> bool"""
+        return _libBornAgainDevice.vdouble2d_T___bool__(self)
 
     def __len__(self):
-        r"""__len__(vdouble2d_t self) -> std::vector< std::vector< double > >::size_type"""
-        return _libBornAgainDevice.vdouble2d_t___len__(self)
+        r"""__len__(vdouble2d_T self) -> std::vector< std::vector< double > >::size_type"""
+        return _libBornAgainDevice.vdouble2d_T___len__(self)
 
     def __getslice__(self, i, j):
-        r"""__getslice__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j) -> vdouble2d_t"""
-        return _libBornAgainDevice.vdouble2d_t___getslice__(self, i, j)
+        r"""__getslice__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j) -> vdouble2d_T"""
+        return _libBornAgainDevice.vdouble2d_T___getslice__(self, i, j)
 
     def __setslice__(self, *args):
         r"""
-        __setslice__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j)
-        __setslice__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j, vdouble2d_t v)
+        __setslice__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j)
+        __setslice__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j, vdouble2d_T v)
         """
-        return _libBornAgainDevice.vdouble2d_t___setslice__(self, *args)
+        return _libBornAgainDevice.vdouble2d_T___setslice__(self, *args)
 
     def __delslice__(self, i, j):
-        r"""__delslice__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j)"""
-        return _libBornAgainDevice.vdouble2d_t___delslice__(self, i, j)
+        r"""__delslice__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j)"""
+        return _libBornAgainDevice.vdouble2d_T___delslice__(self, i, j)
 
     def __delitem__(self, *args):
         r"""
-        __delitem__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i)
-        __delitem__(vdouble2d_t self, SWIGPY_SLICEOBJECT * slice)
+        __delitem__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i)
+        __delitem__(vdouble2d_T self, SWIGPY_SLICEOBJECT * slice)
         """
-        return _libBornAgainDevice.vdouble2d_t___delitem__(self, *args)
+        return _libBornAgainDevice.vdouble2d_T___delitem__(self, *args)
 
     def __getitem__(self, *args):
         r"""
-        __getitem__(vdouble2d_t self, SWIGPY_SLICEOBJECT * slice) -> vdouble2d_t
-        __getitem__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i) -> vdouble1d_t
+        __getitem__(vdouble2d_T self, SWIGPY_SLICEOBJECT * slice) -> vdouble2d_T
+        __getitem__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i) -> vdouble1d_T
         """
-        return _libBornAgainDevice.vdouble2d_t___getitem__(self, *args)
+        return _libBornAgainDevice.vdouble2d_T___getitem__(self, *args)
 
     def __setitem__(self, *args):
         r"""
-        __setitem__(vdouble2d_t self, SWIGPY_SLICEOBJECT * slice, vdouble2d_t v)
-        __setitem__(vdouble2d_t self, SWIGPY_SLICEOBJECT * slice)
-        __setitem__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i, vdouble1d_t x)
+        __setitem__(vdouble2d_T self, SWIGPY_SLICEOBJECT * slice, vdouble2d_T v)
+        __setitem__(vdouble2d_T self, SWIGPY_SLICEOBJECT * slice)
+        __setitem__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i, vdouble1d_T x)
         """
-        return _libBornAgainDevice.vdouble2d_t___setitem__(self, *args)
+        return _libBornAgainDevice.vdouble2d_T___setitem__(self, *args)
 
     def pop(self):
-        r"""pop(vdouble2d_t self) -> vdouble1d_t"""
-        return _libBornAgainDevice.vdouble2d_t_pop(self)
+        r"""pop(vdouble2d_T self) -> vdouble1d_T"""
+        return _libBornAgainDevice.vdouble2d_T_pop(self)
 
     def append(self, x):
-        r"""append(vdouble2d_t self, vdouble1d_t x)"""
-        return _libBornAgainDevice.vdouble2d_t_append(self, x)
+        r"""append(vdouble2d_T self, vdouble1d_T x)"""
+        return _libBornAgainDevice.vdouble2d_T_append(self, x)
 
     def empty(self):
-        r"""empty(vdouble2d_t self) -> bool"""
-        return _libBornAgainDevice.vdouble2d_t_empty(self)
+        r"""empty(vdouble2d_T self) -> bool"""
+        return _libBornAgainDevice.vdouble2d_T_empty(self)
 
     def size(self):
-        r"""size(vdouble2d_t self) -> std::vector< std::vector< double > >::size_type"""
-        return _libBornAgainDevice.vdouble2d_t_size(self)
+        r"""size(vdouble2d_T self) -> std::vector< std::vector< double > >::size_type"""
+        return _libBornAgainDevice.vdouble2d_T_size(self)
 
     def swap(self, v):
-        r"""swap(vdouble2d_t self, vdouble2d_t v)"""
-        return _libBornAgainDevice.vdouble2d_t_swap(self, v)
+        r"""swap(vdouble2d_T self, vdouble2d_T v)"""
+        return _libBornAgainDevice.vdouble2d_T_swap(self, v)
 
     def begin(self):
-        r"""begin(vdouble2d_t self) -> std::vector< std::vector< double > >::iterator"""
-        return _libBornAgainDevice.vdouble2d_t_begin(self)
+        r"""begin(vdouble2d_T self) -> std::vector< std::vector< double > >::iterator"""
+        return _libBornAgainDevice.vdouble2d_T_begin(self)
 
     def end(self):
-        r"""end(vdouble2d_t self) -> std::vector< std::vector< double > >::iterator"""
-        return _libBornAgainDevice.vdouble2d_t_end(self)
+        r"""end(vdouble2d_T self) -> std::vector< std::vector< double > >::iterator"""
+        return _libBornAgainDevice.vdouble2d_T_end(self)
 
     def rbegin(self):
-        r"""rbegin(vdouble2d_t self) -> std::vector< std::vector< double > >::reverse_iterator"""
-        return _libBornAgainDevice.vdouble2d_t_rbegin(self)
+        r"""rbegin(vdouble2d_T self) -> std::vector< std::vector< double > >::reverse_iterator"""
+        return _libBornAgainDevice.vdouble2d_T_rbegin(self)
 
     def rend(self):
-        r"""rend(vdouble2d_t self) -> std::vector< std::vector< double > >::reverse_iterator"""
-        return _libBornAgainDevice.vdouble2d_t_rend(self)
+        r"""rend(vdouble2d_T self) -> std::vector< std::vector< double > >::reverse_iterator"""
+        return _libBornAgainDevice.vdouble2d_T_rend(self)
 
     def clear(self):
-        r"""clear(vdouble2d_t self)"""
-        return _libBornAgainDevice.vdouble2d_t_clear(self)
+        r"""clear(vdouble2d_T self)"""
+        return _libBornAgainDevice.vdouble2d_T_clear(self)
 
     def get_allocator(self):
-        r"""get_allocator(vdouble2d_t self) -> std::vector< std::vector< double > >::allocator_type"""
-        return _libBornAgainDevice.vdouble2d_t_get_allocator(self)
+        r"""get_allocator(vdouble2d_T self) -> std::vector< std::vector< double > >::allocator_type"""
+        return _libBornAgainDevice.vdouble2d_T_get_allocator(self)
 
     def pop_back(self):
-        r"""pop_back(vdouble2d_t self)"""
-        return _libBornAgainDevice.vdouble2d_t_pop_back(self)
+        r"""pop_back(vdouble2d_T self)"""
+        return _libBornAgainDevice.vdouble2d_T_pop_back(self)
 
     def erase(self, *args):
         r"""
-        erase(vdouble2d_t self, std::vector< std::vector< double > >::iterator pos) -> std::vector< std::vector< double > >::iterator
-        erase(vdouble2d_t self, std::vector< std::vector< double > >::iterator first, std::vector< std::vector< double > >::iterator last) -> std::vector< std::vector< double > >::iterator
+        erase(vdouble2d_T self, std::vector< std::vector< double > >::iterator pos) -> std::vector< std::vector< double > >::iterator
+        erase(vdouble2d_T self, std::vector< std::vector< double > >::iterator first, std::vector< std::vector< double > >::iterator last) -> std::vector< std::vector< double > >::iterator
         """
-        return _libBornAgainDevice.vdouble2d_t_erase(self, *args)
+        return _libBornAgainDevice.vdouble2d_T_erase(self, *args)
 
     def __init__(self, *args):
         r"""
-        __init__(vdouble2d_t self) -> vdouble2d_t
-        __init__(vdouble2d_t self, vdouble2d_t other) -> vdouble2d_t
-        __init__(vdouble2d_t self, std::vector< std::vector< double > >::size_type size) -> vdouble2d_t
-        __init__(vdouble2d_t self, std::vector< std::vector< double > >::size_type size, vdouble1d_t value) -> vdouble2d_t
+        __init__(vdouble2d_T self) -> vdouble2d_T
+        __init__(vdouble2d_T self, vdouble2d_T other) -> vdouble2d_T
+        __init__(vdouble2d_T self, std::vector< std::vector< double > >::size_type size) -> vdouble2d_T
+        __init__(vdouble2d_T self, std::vector< std::vector< double > >::size_type size, vdouble1d_T value) -> vdouble2d_T
         """
-        _libBornAgainDevice.vdouble2d_t_swiginit(self, _libBornAgainDevice.new_vdouble2d_t(*args))
+        _libBornAgainDevice.vdouble2d_T_swiginit(self, _libBornAgainDevice.new_vdouble2d_T(*args))
 
     def push_back(self, x):
-        r"""push_back(vdouble2d_t self, vdouble1d_t x)"""
-        return _libBornAgainDevice.vdouble2d_t_push_back(self, x)
+        r"""push_back(vdouble2d_T self, vdouble1d_T x)"""
+        return _libBornAgainDevice.vdouble2d_T_push_back(self, x)
 
     def front(self):
-        r"""front(vdouble2d_t self) -> vdouble1d_t"""
-        return _libBornAgainDevice.vdouble2d_t_front(self)
+        r"""front(vdouble2d_T self) -> vdouble1d_T"""
+        return _libBornAgainDevice.vdouble2d_T_front(self)
 
     def back(self):
-        r"""back(vdouble2d_t self) -> vdouble1d_t"""
-        return _libBornAgainDevice.vdouble2d_t_back(self)
+        r"""back(vdouble2d_T self) -> vdouble1d_T"""
+        return _libBornAgainDevice.vdouble2d_T_back(self)
 
     def assign(self, n, x):
-        r"""assign(vdouble2d_t self, std::vector< std::vector< double > >::size_type n, vdouble1d_t x)"""
-        return _libBornAgainDevice.vdouble2d_t_assign(self, n, x)
+        r"""assign(vdouble2d_T self, std::vector< std::vector< double > >::size_type n, vdouble1d_T x)"""
+        return _libBornAgainDevice.vdouble2d_T_assign(self, n, x)
 
     def resize(self, *args):
         r"""
-        resize(vdouble2d_t self, std::vector< std::vector< double > >::size_type new_size)
-        resize(vdouble2d_t self, std::vector< std::vector< double > >::size_type new_size, vdouble1d_t x)
+        resize(vdouble2d_T self, std::vector< std::vector< double > >::size_type new_size)
+        resize(vdouble2d_T self, std::vector< std::vector< double > >::size_type new_size, vdouble1d_T x)
         """
-        return _libBornAgainDevice.vdouble2d_t_resize(self, *args)
+        return _libBornAgainDevice.vdouble2d_T_resize(self, *args)
 
     def insert(self, *args):
         r"""
-        insert(vdouble2d_t self, std::vector< std::vector< double > >::iterator pos, vdouble1d_t x) -> std::vector< std::vector< double > >::iterator
-        insert(vdouble2d_t self, std::vector< std::vector< double > >::iterator pos, std::vector< std::vector< double > >::size_type n, vdouble1d_t x)
+        insert(vdouble2d_T self, std::vector< std::vector< double > >::iterator pos, vdouble1d_T x) -> std::vector< std::vector< double > >::iterator
+        insert(vdouble2d_T self, std::vector< std::vector< double > >::iterator pos, std::vector< std::vector< double > >::size_type n, vdouble1d_T x)
         """
-        return _libBornAgainDevice.vdouble2d_t_insert(self, *args)
+        return _libBornAgainDevice.vdouble2d_T_insert(self, *args)
 
     def reserve(self, n):
-        r"""reserve(vdouble2d_t self, std::vector< std::vector< double > >::size_type n)"""
-        return _libBornAgainDevice.vdouble2d_t_reserve(self, n)
+        r"""reserve(vdouble2d_T self, std::vector< std::vector< double > >::size_type n)"""
+        return _libBornAgainDevice.vdouble2d_T_reserve(self, n)
 
     def capacity(self):
-        r"""capacity(vdouble2d_t self) -> std::vector< std::vector< double > >::size_type"""
-        return _libBornAgainDevice.vdouble2d_t_capacity(self)
-    __swig_destroy__ = _libBornAgainDevice.delete_vdouble2d_t
+        r"""capacity(vdouble2d_T self) -> std::vector< std::vector< double > >::size_type"""
+        return _libBornAgainDevice.vdouble2d_T_capacity(self)
+    __swig_destroy__ = _libBornAgainDevice.delete_vdouble2d_T
 
-# Register vdouble2d_t in _libBornAgainDevice:
-_libBornAgainDevice.vdouble2d_t_swigregister(vdouble2d_t)
-class vector_integer_t(object):
+# Register vdouble2d_T in _libBornAgainDevice:
+_libBornAgainDevice.vdouble2d_T_swigregister(vdouble2d_T)
+class vector_integer_T(object):
     r"""Proxy of C++ std::vector< int > class."""
 
     thisown = property(lambda x: x.this.own(), lambda x, v: x.this.own(v), doc="The membership flag")
     __repr__ = _swig_repr
 
     def iterator(self):
-        r"""iterator(vector_integer_t self) -> SwigPyIterator"""
-        return _libBornAgainDevice.vector_integer_t_iterator(self)
+        r"""iterator(vector_integer_T self) -> SwigPyIterator"""
+        return _libBornAgainDevice.vector_integer_T_iterator(self)
     def __iter__(self):
         return self.iterator()
 
     def __nonzero__(self):
-        r"""__nonzero__(vector_integer_t self) -> bool"""
-        return _libBornAgainDevice.vector_integer_t___nonzero__(self)
+        r"""__nonzero__(vector_integer_T self) -> bool"""
+        return _libBornAgainDevice.vector_integer_T___nonzero__(self)
 
     def __bool__(self):
-        r"""__bool__(vector_integer_t self) -> bool"""
-        return _libBornAgainDevice.vector_integer_t___bool__(self)
+        r"""__bool__(vector_integer_T self) -> bool"""
+        return _libBornAgainDevice.vector_integer_T___bool__(self)
 
     def __len__(self):
-        r"""__len__(vector_integer_t self) -> std::vector< int >::size_type"""
-        return _libBornAgainDevice.vector_integer_t___len__(self)
+        r"""__len__(vector_integer_T self) -> std::vector< int >::size_type"""
+        return _libBornAgainDevice.vector_integer_T___len__(self)
 
     def __getslice__(self, i, j):
-        r"""__getslice__(vector_integer_t self, std::vector< int >::difference_type i, std::vector< int >::difference_type j) -> vector_integer_t"""
-        return _libBornAgainDevice.vector_integer_t___getslice__(self, i, j)
+        r"""__getslice__(vector_integer_T self, std::vector< int >::difference_type i, std::vector< int >::difference_type j) -> vector_integer_T"""
+        return _libBornAgainDevice.vector_integer_T___getslice__(self, i, j)
 
     def __setslice__(self, *args):
         r"""
-        __setslice__(vector_integer_t self, std::vector< int >::difference_type i, std::vector< int >::difference_type j)
-        __setslice__(vector_integer_t self, std::vector< int >::difference_type i, std::vector< int >::difference_type j, vector_integer_t v)
+        __setslice__(vector_integer_T self, std::vector< int >::difference_type i, std::vector< int >::difference_type j)
+        __setslice__(vector_integer_T self, std::vector< int >::difference_type i, std::vector< int >::difference_type j, vector_integer_T v)
         """
-        return _libBornAgainDevice.vector_integer_t___setslice__(self, *args)
+        return _libBornAgainDevice.vector_integer_T___setslice__(self, *args)
 
     def __delslice__(self, i, j):
-        r"""__delslice__(vector_integer_t self, std::vector< int >::difference_type i, std::vector< int >::difference_type j)"""
-        return _libBornAgainDevice.vector_integer_t___delslice__(self, i, j)
+        r"""__delslice__(vector_integer_T self, std::vector< int >::difference_type i, std::vector< int >::difference_type j)"""
+        return _libBornAgainDevice.vector_integer_T___delslice__(self, i, j)
 
     def __delitem__(self, *args):
         r"""
-        __delitem__(vector_integer_t self, std::vector< int >::difference_type i)
-        __delitem__(vector_integer_t self, SWIGPY_SLICEOBJECT * slice)
+        __delitem__(vector_integer_T self, std::vector< int >::difference_type i)
+        __delitem__(vector_integer_T self, SWIGPY_SLICEOBJECT * slice)
         """
-        return _libBornAgainDevice.vector_integer_t___delitem__(self, *args)
+        return _libBornAgainDevice.vector_integer_T___delitem__(self, *args)
 
     def __getitem__(self, *args):
         r"""
-        __getitem__(vector_integer_t self, SWIGPY_SLICEOBJECT * slice) -> vector_integer_t
-        __getitem__(vector_integer_t self, std::vector< int >::difference_type i) -> std::vector< int >::value_type const &
+        __getitem__(vector_integer_T self, SWIGPY_SLICEOBJECT * slice) -> vector_integer_T
+        __getitem__(vector_integer_T self, std::vector< int >::difference_type i) -> std::vector< int >::value_type const &
         """
-        return _libBornAgainDevice.vector_integer_t___getitem__(self, *args)
+        return _libBornAgainDevice.vector_integer_T___getitem__(self, *args)
 
     def __setitem__(self, *args):
         r"""
-        __setitem__(vector_integer_t self, SWIGPY_SLICEOBJECT * slice, vector_integer_t v)
-        __setitem__(vector_integer_t self, SWIGPY_SLICEOBJECT * slice)
-        __setitem__(vector_integer_t self, std::vector< int >::difference_type i, std::vector< int >::value_type const & x)
+        __setitem__(vector_integer_T self, SWIGPY_SLICEOBJECT * slice, vector_integer_T v)
+        __setitem__(vector_integer_T self, SWIGPY_SLICEOBJECT * slice)
+        __setitem__(vector_integer_T self, std::vector< int >::difference_type i, std::vector< int >::value_type const & x)
         """
-        return _libBornAgainDevice.vector_integer_t___setitem__(self, *args)
+        return _libBornAgainDevice.vector_integer_T___setitem__(self, *args)
 
     def pop(self):
-        r"""pop(vector_integer_t self) -> std::vector< int >::value_type"""
-        return _libBornAgainDevice.vector_integer_t_pop(self)
+        r"""pop(vector_integer_T self) -> std::vector< int >::value_type"""
+        return _libBornAgainDevice.vector_integer_T_pop(self)
 
     def append(self, x):
-        r"""append(vector_integer_t self, std::vector< int >::value_type const & x)"""
-        return _libBornAgainDevice.vector_integer_t_append(self, x)
+        r"""append(vector_integer_T self, std::vector< int >::value_type const & x)"""
+        return _libBornAgainDevice.vector_integer_T_append(self, x)
 
     def empty(self):
-        r"""empty(vector_integer_t self) -> bool"""
-        return _libBornAgainDevice.vector_integer_t_empty(self)
+        r"""empty(vector_integer_T self) -> bool"""
+        return _libBornAgainDevice.vector_integer_T_empty(self)
 
     def size(self):
-        r"""size(vector_integer_t self) -> std::vector< int >::size_type"""
-        return _libBornAgainDevice.vector_integer_t_size(self)
+        r"""size(vector_integer_T self) -> std::vector< int >::size_type"""
+        return _libBornAgainDevice.vector_integer_T_size(self)
 
     def swap(self, v):
-        r"""swap(vector_integer_t self, vector_integer_t v)"""
-        return _libBornAgainDevice.vector_integer_t_swap(self, v)
+        r"""swap(vector_integer_T self, vector_integer_T v)"""
+        return _libBornAgainDevice.vector_integer_T_swap(self, v)
 
     def begin(self):
-        r"""begin(vector_integer_t self) -> std::vector< int >::iterator"""
-        return _libBornAgainDevice.vector_integer_t_begin(self)
+        r"""begin(vector_integer_T self) -> std::vector< int >::iterator"""
+        return _libBornAgainDevice.vector_integer_T_begin(self)
 
     def end(self):
-        r"""end(vector_integer_t self) -> std::vector< int >::iterator"""
-        return _libBornAgainDevice.vector_integer_t_end(self)
+        r"""end(vector_integer_T self) -> std::vector< int >::iterator"""
+        return _libBornAgainDevice.vector_integer_T_end(self)
 
     def rbegin(self):
-        r"""rbegin(vector_integer_t self) -> std::vector< int >::reverse_iterator"""
-        return _libBornAgainDevice.vector_integer_t_rbegin(self)
+        r"""rbegin(vector_integer_T self) -> std::vector< int >::reverse_iterator"""
+        return _libBornAgainDevice.vector_integer_T_rbegin(self)
 
     def rend(self):
-        r"""rend(vector_integer_t self) -> std::vector< int >::reverse_iterator"""
-        return _libBornAgainDevice.vector_integer_t_rend(self)
+        r"""rend(vector_integer_T self) -> std::vector< int >::reverse_iterator"""
+        return _libBornAgainDevice.vector_integer_T_rend(self)
 
     def clear(self):
-        r"""clear(vector_integer_t self)"""
-        return _libBornAgainDevice.vector_integer_t_clear(self)
+        r"""clear(vector_integer_T self)"""
+        return _libBornAgainDevice.vector_integer_T_clear(self)
 
     def get_allocator(self):
-        r"""get_allocator(vector_integer_t self) -> std::vector< int >::allocator_type"""
-        return _libBornAgainDevice.vector_integer_t_get_allocator(self)
+        r"""get_allocator(vector_integer_T self) -> std::vector< int >::allocator_type"""
+        return _libBornAgainDevice.vector_integer_T_get_allocator(self)
 
     def pop_back(self):
-        r"""pop_back(vector_integer_t self)"""
-        return _libBornAgainDevice.vector_integer_t_pop_back(self)
+        r"""pop_back(vector_integer_T self)"""
+        return _libBornAgainDevice.vector_integer_T_pop_back(self)
 
     def erase(self, *args):
         r"""
-        erase(vector_integer_t self, std::vector< int >::iterator pos) -> std::vector< int >::iterator
-        erase(vector_integer_t self, std::vector< int >::iterator first, std::vector< int >::iterator last) -> std::vector< int >::iterator
+        erase(vector_integer_T self, std::vector< int >::iterator pos) -> std::vector< int >::iterator
+        erase(vector_integer_T self, std::vector< int >::iterator first, std::vector< int >::iterator last) -> std::vector< int >::iterator
         """
-        return _libBornAgainDevice.vector_integer_t_erase(self, *args)
+        return _libBornAgainDevice.vector_integer_T_erase(self, *args)
 
     def __init__(self, *args):
         r"""
-        __init__(vector_integer_t self) -> vector_integer_t
-        __init__(vector_integer_t self, vector_integer_t other) -> vector_integer_t
-        __init__(vector_integer_t self, std::vector< int >::size_type size) -> vector_integer_t
-        __init__(vector_integer_t self, std::vector< int >::size_type size, std::vector< int >::value_type const & value) -> vector_integer_t
+        __init__(vector_integer_T self) -> vector_integer_T
+        __init__(vector_integer_T self, vector_integer_T other) -> vector_integer_T
+        __init__(vector_integer_T self, std::vector< int >::size_type size) -> vector_integer_T
+        __init__(vector_integer_T self, std::vector< int >::size_type size, std::vector< int >::value_type const & value) -> vector_integer_T
         """
-        _libBornAgainDevice.vector_integer_t_swiginit(self, _libBornAgainDevice.new_vector_integer_t(*args))
+        _libBornAgainDevice.vector_integer_T_swiginit(self, _libBornAgainDevice.new_vector_integer_T(*args))
 
     def push_back(self, x):
-        r"""push_back(vector_integer_t self, std::vector< int >::value_type const & x)"""
-        return _libBornAgainDevice.vector_integer_t_push_back(self, x)
+        r"""push_back(vector_integer_T self, std::vector< int >::value_type const & x)"""
+        return _libBornAgainDevice.vector_integer_T_push_back(self, x)
 
     def front(self):
-        r"""front(vector_integer_t self) -> std::vector< int >::value_type const &"""
-        return _libBornAgainDevice.vector_integer_t_front(self)
+        r"""front(vector_integer_T self) -> std::vector< int >::value_type const &"""
+        return _libBornAgainDevice.vector_integer_T_front(self)
 
     def back(self):
-        r"""back(vector_integer_t self) -> std::vector< int >::value_type const &"""
-        return _libBornAgainDevice.vector_integer_t_back(self)
+        r"""back(vector_integer_T self) -> std::vector< int >::value_type const &"""
+        return _libBornAgainDevice.vector_integer_T_back(self)
 
     def assign(self, n, x):
-        r"""assign(vector_integer_t self, std::vector< int >::size_type n, std::vector< int >::value_type const & x)"""
-        return _libBornAgainDevice.vector_integer_t_assign(self, n, x)
+        r"""assign(vector_integer_T self, std::vector< int >::size_type n, std::vector< int >::value_type const & x)"""
+        return _libBornAgainDevice.vector_integer_T_assign(self, n, x)
 
     def resize(self, *args):
         r"""
-        resize(vector_integer_t self, std::vector< int >::size_type new_size)
-        resize(vector_integer_t self, std::vector< int >::size_type new_size, std::vector< int >::value_type const & x)
+        resize(vector_integer_T self, std::vector< int >::size_type new_size)
+        resize(vector_integer_T self, std::vector< int >::size_type new_size, std::vector< int >::value_type const & x)
         """
-        return _libBornAgainDevice.vector_integer_t_resize(self, *args)
+        return _libBornAgainDevice.vector_integer_T_resize(self, *args)
 
     def insert(self, *args):
         r"""
-        insert(vector_integer_t self, std::vector< int >::iterator pos, std::vector< int >::value_type const & x) -> std::vector< int >::iterator
-        insert(vector_integer_t self, std::vector< int >::iterator pos, std::vector< int >::size_type n, std::vector< int >::value_type const & x)
+        insert(vector_integer_T self, std::vector< int >::iterator pos, std::vector< int >::value_type const & x) -> std::vector< int >::iterator
+        insert(vector_integer_T self, std::vector< int >::iterator pos, std::vector< int >::size_type n, std::vector< int >::value_type const & x)
         """
-        return _libBornAgainDevice.vector_integer_t_insert(self, *args)
+        return _libBornAgainDevice.vector_integer_T_insert(self, *args)
 
     def reserve(self, n):
-        r"""reserve(vector_integer_t self, std::vector< int >::size_type n)"""
-        return _libBornAgainDevice.vector_integer_t_reserve(self, n)
+        r"""reserve(vector_integer_T self, std::vector< int >::size_type n)"""
+        return _libBornAgainDevice.vector_integer_T_reserve(self, n)
 
     def capacity(self):
-        r"""capacity(vector_integer_t self) -> std::vector< int >::size_type"""
-        return _libBornAgainDevice.vector_integer_t_capacity(self)
-    __swig_destroy__ = _libBornAgainDevice.delete_vector_integer_t
+        r"""capacity(vector_integer_T self) -> std::vector< int >::size_type"""
+        return _libBornAgainDevice.vector_integer_T_capacity(self)
+    __swig_destroy__ = _libBornAgainDevice.delete_vector_integer_T
 
-# Register vector_integer_t in _libBornAgainDevice:
-_libBornAgainDevice.vector_integer_t_swigregister(vector_integer_t)
-class vinteger2d_t(object):
+# Register vector_integer_T in _libBornAgainDevice:
+_libBornAgainDevice.vector_integer_T_swigregister(vector_integer_T)
+class vinteger2d_T(object):
     r"""Proxy of C++ std::vector< std::vector< int > > class."""
 
     thisown = property(lambda x: x.this.own(), lambda x, v: x.this.own(v), doc="The membership flag")
     __repr__ = _swig_repr
 
     def iterator(self):
-        r"""iterator(vinteger2d_t self) -> SwigPyIterator"""
-        return _libBornAgainDevice.vinteger2d_t_iterator(self)
+        r"""iterator(vinteger2d_T self) -> SwigPyIterator"""
+        return _libBornAgainDevice.vinteger2d_T_iterator(self)
     def __iter__(self):
         return self.iterator()
 
     def __nonzero__(self):
-        r"""__nonzero__(vinteger2d_t self) -> bool"""
-        return _libBornAgainDevice.vinteger2d_t___nonzero__(self)
+        r"""__nonzero__(vinteger2d_T self) -> bool"""
+        return _libBornAgainDevice.vinteger2d_T___nonzero__(self)
 
     def __bool__(self):
-        r"""__bool__(vinteger2d_t self) -> bool"""
-        return _libBornAgainDevice.vinteger2d_t___bool__(self)
+        r"""__bool__(vinteger2d_T self) -> bool"""
+        return _libBornAgainDevice.vinteger2d_T___bool__(self)
 
     def __len__(self):
-        r"""__len__(vinteger2d_t self) -> std::vector< std::vector< int > >::size_type"""
-        return _libBornAgainDevice.vinteger2d_t___len__(self)
+        r"""__len__(vinteger2d_T self) -> std::vector< std::vector< int > >::size_type"""
+        return _libBornAgainDevice.vinteger2d_T___len__(self)
 
     def __getslice__(self, i, j):
-        r"""__getslice__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j) -> vinteger2d_t"""
-        return _libBornAgainDevice.vinteger2d_t___getslice__(self, i, j)
+        r"""__getslice__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j) -> vinteger2d_T"""
+        return _libBornAgainDevice.vinteger2d_T___getslice__(self, i, j)
 
     def __setslice__(self, *args):
         r"""
-        __setslice__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j)
-        __setslice__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j, vinteger2d_t v)
+        __setslice__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j)
+        __setslice__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j, vinteger2d_T v)
         """
-        return _libBornAgainDevice.vinteger2d_t___setslice__(self, *args)
+        return _libBornAgainDevice.vinteger2d_T___setslice__(self, *args)
 
     def __delslice__(self, i, j):
-        r"""__delslice__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j)"""
-        return _libBornAgainDevice.vinteger2d_t___delslice__(self, i, j)
+        r"""__delslice__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j)"""
+        return _libBornAgainDevice.vinteger2d_T___delslice__(self, i, j)
 
     def __delitem__(self, *args):
         r"""
-        __delitem__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i)
-        __delitem__(vinteger2d_t self, SWIGPY_SLICEOBJECT * slice)
+        __delitem__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i)
+        __delitem__(vinteger2d_T self, SWIGPY_SLICEOBJECT * slice)
         """
-        return _libBornAgainDevice.vinteger2d_t___delitem__(self, *args)
+        return _libBornAgainDevice.vinteger2d_T___delitem__(self, *args)
 
     def __getitem__(self, *args):
         r"""
-        __getitem__(vinteger2d_t self, SWIGPY_SLICEOBJECT * slice) -> vinteger2d_t
-        __getitem__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i) -> vector_integer_t
+        __getitem__(vinteger2d_T self, SWIGPY_SLICEOBJECT * slice) -> vinteger2d_T
+        __getitem__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i) -> vector_integer_T
         """
-        return _libBornAgainDevice.vinteger2d_t___getitem__(self, *args)
+        return _libBornAgainDevice.vinteger2d_T___getitem__(self, *args)
 
     def __setitem__(self, *args):
         r"""
-        __setitem__(vinteger2d_t self, SWIGPY_SLICEOBJECT * slice, vinteger2d_t v)
-        __setitem__(vinteger2d_t self, SWIGPY_SLICEOBJECT * slice)
-        __setitem__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i, vector_integer_t x)
+        __setitem__(vinteger2d_T self, SWIGPY_SLICEOBJECT * slice, vinteger2d_T v)
+        __setitem__(vinteger2d_T self, SWIGPY_SLICEOBJECT * slice)
+        __setitem__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i, vector_integer_T x)
         """
-        return _libBornAgainDevice.vinteger2d_t___setitem__(self, *args)
+        return _libBornAgainDevice.vinteger2d_T___setitem__(self, *args)
 
     def pop(self):
-        r"""pop(vinteger2d_t self) -> vector_integer_t"""
-        return _libBornAgainDevice.vinteger2d_t_pop(self)
+        r"""pop(vinteger2d_T self) -> vector_integer_T"""
+        return _libBornAgainDevice.vinteger2d_T_pop(self)
 
     def append(self, x):
-        r"""append(vinteger2d_t self, vector_integer_t x)"""
-        return _libBornAgainDevice.vinteger2d_t_append(self, x)
+        r"""append(vinteger2d_T self, vector_integer_T x)"""
+        return _libBornAgainDevice.vinteger2d_T_append(self, x)
 
     def empty(self):
-        r"""empty(vinteger2d_t self) -> bool"""
-        return _libBornAgainDevice.vinteger2d_t_empty(self)
+        r"""empty(vinteger2d_T self) -> bool"""
+        return _libBornAgainDevice.vinteger2d_T_empty(self)
 
     def size(self):
-        r"""size(vinteger2d_t self) -> std::vector< std::vector< int > >::size_type"""
-        return _libBornAgainDevice.vinteger2d_t_size(self)
+        r"""size(vinteger2d_T self) -> std::vector< std::vector< int > >::size_type"""
+        return _libBornAgainDevice.vinteger2d_T_size(self)
 
     def swap(self, v):
-        r"""swap(vinteger2d_t self, vinteger2d_t v)"""
-        return _libBornAgainDevice.vinteger2d_t_swap(self, v)
+        r"""swap(vinteger2d_T self, vinteger2d_T v)"""
+        return _libBornAgainDevice.vinteger2d_T_swap(self, v)
 
     def begin(self):
-        r"""begin(vinteger2d_t self) -> std::vector< std::vector< int > >::iterator"""
-        return _libBornAgainDevice.vinteger2d_t_begin(self)
+        r"""begin(vinteger2d_T self) -> std::vector< std::vector< int > >::iterator"""
+        return _libBornAgainDevice.vinteger2d_T_begin(self)
 
     def end(self):
-        r"""end(vinteger2d_t self) -> std::vector< std::vector< int > >::iterator"""
-        return _libBornAgainDevice.vinteger2d_t_end(self)
+        r"""end(vinteger2d_T self) -> std::vector< std::vector< int > >::iterator"""
+        return _libBornAgainDevice.vinteger2d_T_end(self)
 
     def rbegin(self):
-        r"""rbegin(vinteger2d_t self) -> std::vector< std::vector< int > >::reverse_iterator"""
-        return _libBornAgainDevice.vinteger2d_t_rbegin(self)
+        r"""rbegin(vinteger2d_T self) -> std::vector< std::vector< int > >::reverse_iterator"""
+        return _libBornAgainDevice.vinteger2d_T_rbegin(self)
 
     def rend(self):
-        r"""rend(vinteger2d_t self) -> std::vector< std::vector< int > >::reverse_iterator"""
-        return _libBornAgainDevice.vinteger2d_t_rend(self)
+        r"""rend(vinteger2d_T self) -> std::vector< std::vector< int > >::reverse_iterator"""
+        return _libBornAgainDevice.vinteger2d_T_rend(self)
 
     def clear(self):
-        r"""clear(vinteger2d_t self)"""
-        return _libBornAgainDevice.vinteger2d_t_clear(self)
+        r"""clear(vinteger2d_T self)"""
+        return _libBornAgainDevice.vinteger2d_T_clear(self)
 
     def get_allocator(self):
-        r"""get_allocator(vinteger2d_t self) -> std::vector< std::vector< int > >::allocator_type"""
-        return _libBornAgainDevice.vinteger2d_t_get_allocator(self)
+        r"""get_allocator(vinteger2d_T self) -> std::vector< std::vector< int > >::allocator_type"""
+        return _libBornAgainDevice.vinteger2d_T_get_allocator(self)
 
     def pop_back(self):
-        r"""pop_back(vinteger2d_t self)"""
-        return _libBornAgainDevice.vinteger2d_t_pop_back(self)
+        r"""pop_back(vinteger2d_T self)"""
+        return _libBornAgainDevice.vinteger2d_T_pop_back(self)
 
     def erase(self, *args):
         r"""
-        erase(vinteger2d_t self, std::vector< std::vector< int > >::iterator pos) -> std::vector< std::vector< int > >::iterator
-        erase(vinteger2d_t self, std::vector< std::vector< int > >::iterator first, std::vector< std::vector< int > >::iterator last) -> std::vector< std::vector< int > >::iterator
+        erase(vinteger2d_T self, std::vector< std::vector< int > >::iterator pos) -> std::vector< std::vector< int > >::iterator
+        erase(vinteger2d_T self, std::vector< std::vector< int > >::iterator first, std::vector< std::vector< int > >::iterator last) -> std::vector< std::vector< int > >::iterator
         """
-        return _libBornAgainDevice.vinteger2d_t_erase(self, *args)
+        return _libBornAgainDevice.vinteger2d_T_erase(self, *args)
 
     def __init__(self, *args):
         r"""
-        __init__(vinteger2d_t self) -> vinteger2d_t
-        __init__(vinteger2d_t self, vinteger2d_t other) -> vinteger2d_t
-        __init__(vinteger2d_t self, std::vector< std::vector< int > >::size_type size) -> vinteger2d_t
-        __init__(vinteger2d_t self, std::vector< std::vector< int > >::size_type size, vector_integer_t value) -> vinteger2d_t
+        __init__(vinteger2d_T self) -> vinteger2d_T
+        __init__(vinteger2d_T self, vinteger2d_T other) -> vinteger2d_T
+        __init__(vinteger2d_T self, std::vector< std::vector< int > >::size_type size) -> vinteger2d_T
+        __init__(vinteger2d_T self, std::vector< std::vector< int > >::size_type size, vector_integer_T value) -> vinteger2d_T
         """
-        _libBornAgainDevice.vinteger2d_t_swiginit(self, _libBornAgainDevice.new_vinteger2d_t(*args))
+        _libBornAgainDevice.vinteger2d_T_swiginit(self, _libBornAgainDevice.new_vinteger2d_T(*args))
 
     def push_back(self, x):
-        r"""push_back(vinteger2d_t self, vector_integer_t x)"""
-        return _libBornAgainDevice.vinteger2d_t_push_back(self, x)
+        r"""push_back(vinteger2d_T self, vector_integer_T x)"""
+        return _libBornAgainDevice.vinteger2d_T_push_back(self, x)
 
     def front(self):
-        r"""front(vinteger2d_t self) -> vector_integer_t"""
-        return _libBornAgainDevice.vinteger2d_t_front(self)
+        r"""front(vinteger2d_T self) -> vector_integer_T"""
+        return _libBornAgainDevice.vinteger2d_T_front(self)
 
     def back(self):
-        r"""back(vinteger2d_t self) -> vector_integer_t"""
-        return _libBornAgainDevice.vinteger2d_t_back(self)
+        r"""back(vinteger2d_T self) -> vector_integer_T"""
+        return _libBornAgainDevice.vinteger2d_T_back(self)
 
     def assign(self, n, x):
-        r"""assign(vinteger2d_t self, std::vector< std::vector< int > >::size_type n, vector_integer_t x)"""
-        return _libBornAgainDevice.vinteger2d_t_assign(self, n, x)
+        r"""assign(vinteger2d_T self, std::vector< std::vector< int > >::size_type n, vector_integer_T x)"""
+        return _libBornAgainDevice.vinteger2d_T_assign(self, n, x)
 
     def resize(self, *args):
         r"""
-        resize(vinteger2d_t self, std::vector< std::vector< int > >::size_type new_size)
-        resize(vinteger2d_t self, std::vector< std::vector< int > >::size_type new_size, vector_integer_t x)
+        resize(vinteger2d_T self, std::vector< std::vector< int > >::size_type new_size)
+        resize(vinteger2d_T self, std::vector< std::vector< int > >::size_type new_size, vector_integer_T x)
         """
-        return _libBornAgainDevice.vinteger2d_t_resize(self, *args)
+        return _libBornAgainDevice.vinteger2d_T_resize(self, *args)
 
     def insert(self, *args):
         r"""
-        insert(vinteger2d_t self, std::vector< std::vector< int > >::iterator pos, vector_integer_t x) -> std::vector< std::vector< int > >::iterator
-        insert(vinteger2d_t self, std::vector< std::vector< int > >::iterator pos, std::vector< std::vector< int > >::size_type n, vector_integer_t x)
+        insert(vinteger2d_T self, std::vector< std::vector< int > >::iterator pos, vector_integer_T x) -> std::vector< std::vector< int > >::iterator
+        insert(vinteger2d_T self, std::vector< std::vector< int > >::iterator pos, std::vector< std::vector< int > >::size_type n, vector_integer_T x)
         """
-        return _libBornAgainDevice.vinteger2d_t_insert(self, *args)
+        return _libBornAgainDevice.vinteger2d_T_insert(self, *args)
 
     def reserve(self, n):
-        r"""reserve(vinteger2d_t self, std::vector< std::vector< int > >::size_type n)"""
-        return _libBornAgainDevice.vinteger2d_t_reserve(self, n)
+        r"""reserve(vinteger2d_T self, std::vector< std::vector< int > >::size_type n)"""
+        return _libBornAgainDevice.vinteger2d_T_reserve(self, n)
 
     def capacity(self):
-        r"""capacity(vinteger2d_t self) -> std::vector< std::vector< int > >::size_type"""
-        return _libBornAgainDevice.vinteger2d_t_capacity(self)
-    __swig_destroy__ = _libBornAgainDevice.delete_vinteger2d_t
+        r"""capacity(vinteger2d_T self) -> std::vector< std::vector< int > >::size_type"""
+        return _libBornAgainDevice.vinteger2d_T_capacity(self)
+    __swig_destroy__ = _libBornAgainDevice.delete_vinteger2d_T
 
-# Register vinteger2d_t in _libBornAgainDevice:
-_libBornAgainDevice.vinteger2d_t_swigregister(vinteger2d_t)
-class vector_longinteger_t(object):
+# Register vinteger2d_T in _libBornAgainDevice:
+_libBornAgainDevice.vinteger2d_T_swigregister(vinteger2d_T)
+class vector_longinteger_T(object):
     r"""Proxy of C++ std::vector< unsigned long > class."""
 
     thisown = property(lambda x: x.this.own(), lambda x, v: x.this.own(v), doc="The membership flag")
     __repr__ = _swig_repr
 
     def iterator(self):
-        r"""iterator(vector_longinteger_t self) -> SwigPyIterator"""
-        return _libBornAgainDevice.vector_longinteger_t_iterator(self)
+        r"""iterator(vector_longinteger_T self) -> SwigPyIterator"""
+        return _libBornAgainDevice.vector_longinteger_T_iterator(self)
     def __iter__(self):
         return self.iterator()
 
     def __nonzero__(self):
-        r"""__nonzero__(vector_longinteger_t self) -> bool"""
-        return _libBornAgainDevice.vector_longinteger_t___nonzero__(self)
+        r"""__nonzero__(vector_longinteger_T self) -> bool"""
+        return _libBornAgainDevice.vector_longinteger_T___nonzero__(self)
 
     def __bool__(self):
-        r"""__bool__(vector_longinteger_t self) -> bool"""
-        return _libBornAgainDevice.vector_longinteger_t___bool__(self)
+        r"""__bool__(vector_longinteger_T self) -> bool"""
+        return _libBornAgainDevice.vector_longinteger_T___bool__(self)
 
     def __len__(self):
-        r"""__len__(vector_longinteger_t self) -> std::vector< unsigned long >::size_type"""
-        return _libBornAgainDevice.vector_longinteger_t___len__(self)
+        r"""__len__(vector_longinteger_T self) -> std::vector< unsigned long >::size_type"""
+        return _libBornAgainDevice.vector_longinteger_T___len__(self)
 
     def __getslice__(self, i, j):
-        r"""__getslice__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j) -> vector_longinteger_t"""
-        return _libBornAgainDevice.vector_longinteger_t___getslice__(self, i, j)
+        r"""__getslice__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j) -> vector_longinteger_T"""
+        return _libBornAgainDevice.vector_longinteger_T___getslice__(self, i, j)
 
     def __setslice__(self, *args):
         r"""
-        __setslice__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j)
-        __setslice__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j, vector_longinteger_t v)
+        __setslice__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j)
+        __setslice__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j, vector_longinteger_T v)
         """
-        return _libBornAgainDevice.vector_longinteger_t___setslice__(self, *args)
+        return _libBornAgainDevice.vector_longinteger_T___setslice__(self, *args)
 
     def __delslice__(self, i, j):
-        r"""__delslice__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j)"""
-        return _libBornAgainDevice.vector_longinteger_t___delslice__(self, i, j)
+        r"""__delslice__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j)"""
+        return _libBornAgainDevice.vector_longinteger_T___delslice__(self, i, j)
 
     def __delitem__(self, *args):
         r"""
-        __delitem__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i)
-        __delitem__(vector_longinteger_t self, SWIGPY_SLICEOBJECT * slice)
+        __delitem__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i)
+        __delitem__(vector_longinteger_T self, SWIGPY_SLICEOBJECT * slice)
         """
-        return _libBornAgainDevice.vector_longinteger_t___delitem__(self, *args)
+        return _libBornAgainDevice.vector_longinteger_T___delitem__(self, *args)
 
     def __getitem__(self, *args):
         r"""
-        __getitem__(vector_longinteger_t self, SWIGPY_SLICEOBJECT * slice) -> vector_longinteger_t
-        __getitem__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i) -> std::vector< unsigned long >::value_type const &
+        __getitem__(vector_longinteger_T self, SWIGPY_SLICEOBJECT * slice) -> vector_longinteger_T
+        __getitem__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i) -> std::vector< unsigned long >::value_type const &
         """
-        return _libBornAgainDevice.vector_longinteger_t___getitem__(self, *args)
+        return _libBornAgainDevice.vector_longinteger_T___getitem__(self, *args)
 
     def __setitem__(self, *args):
         r"""
-        __setitem__(vector_longinteger_t self, SWIGPY_SLICEOBJECT * slice, vector_longinteger_t v)
-        __setitem__(vector_longinteger_t self, SWIGPY_SLICEOBJECT * slice)
-        __setitem__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::value_type const & x)
+        __setitem__(vector_longinteger_T self, SWIGPY_SLICEOBJECT * slice, vector_longinteger_T v)
+        __setitem__(vector_longinteger_T self, SWIGPY_SLICEOBJECT * slice)
+        __setitem__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::value_type const & x)
         """
-        return _libBornAgainDevice.vector_longinteger_t___setitem__(self, *args)
+        return _libBornAgainDevice.vector_longinteger_T___setitem__(self, *args)
 
     def pop(self):
-        r"""pop(vector_longinteger_t self) -> std::vector< unsigned long >::value_type"""
-        return _libBornAgainDevice.vector_longinteger_t_pop(self)
+        r"""pop(vector_longinteger_T self) -> std::vector< unsigned long >::value_type"""
+        return _libBornAgainDevice.vector_longinteger_T_pop(self)
 
     def append(self, x):
-        r"""append(vector_longinteger_t self, std::vector< unsigned long >::value_type const & x)"""
-        return _libBornAgainDevice.vector_longinteger_t_append(self, x)
+        r"""append(vector_longinteger_T self, std::vector< unsigned long >::value_type const & x)"""
+        return _libBornAgainDevice.vector_longinteger_T_append(self, x)
 
     def empty(self):
-        r"""empty(vector_longinteger_t self) -> bool"""
-        return _libBornAgainDevice.vector_longinteger_t_empty(self)
+        r"""empty(vector_longinteger_T self) -> bool"""
+        return _libBornAgainDevice.vector_longinteger_T_empty(self)
 
     def size(self):
-        r"""size(vector_longinteger_t self) -> std::vector< unsigned long >::size_type"""
-        return _libBornAgainDevice.vector_longinteger_t_size(self)
+        r"""size(vector_longinteger_T self) -> std::vector< unsigned long >::size_type"""
+        return _libBornAgainDevice.vector_longinteger_T_size(self)
 
     def swap(self, v):
-        r"""swap(vector_longinteger_t self, vector_longinteger_t v)"""
-        return _libBornAgainDevice.vector_longinteger_t_swap(self, v)
+        r"""swap(vector_longinteger_T self, vector_longinteger_T v)"""
+        return _libBornAgainDevice.vector_longinteger_T_swap(self, v)
 
     def begin(self):
-        r"""begin(vector_longinteger_t self) -> std::vector< unsigned long >::iterator"""
-        return _libBornAgainDevice.vector_longinteger_t_begin(self)
+        r"""begin(vector_longinteger_T self) -> std::vector< unsigned long >::iterator"""
+        return _libBornAgainDevice.vector_longinteger_T_begin(self)
 
     def end(self):
-        r"""end(vector_longinteger_t self) -> std::vector< unsigned long >::iterator"""
-        return _libBornAgainDevice.vector_longinteger_t_end(self)
+        r"""end(vector_longinteger_T self) -> std::vector< unsigned long >::iterator"""
+        return _libBornAgainDevice.vector_longinteger_T_end(self)
 
     def rbegin(self):
-        r"""rbegin(vector_longinteger_t self) -> std::vector< unsigned long >::reverse_iterator"""
-        return _libBornAgainDevice.vector_longinteger_t_rbegin(self)
+        r"""rbegin(vector_longinteger_T self) -> std::vector< unsigned long >::reverse_iterator"""
+        return _libBornAgainDevice.vector_longinteger_T_rbegin(self)
 
     def rend(self):
-        r"""rend(vector_longinteger_t self) -> std::vector< unsigned long >::reverse_iterator"""
-        return _libBornAgainDevice.vector_longinteger_t_rend(self)
+        r"""rend(vector_longinteger_T self) -> std::vector< unsigned long >::reverse_iterator"""
+        return _libBornAgainDevice.vector_longinteger_T_rend(self)
 
     def clear(self):
-        r"""clear(vector_longinteger_t self)"""
-        return _libBornAgainDevice.vector_longinteger_t_clear(self)
+        r"""clear(vector_longinteger_T self)"""
+        return _libBornAgainDevice.vector_longinteger_T_clear(self)
 
     def get_allocator(self):
-        r"""get_allocator(vector_longinteger_t self) -> std::vector< unsigned long >::allocator_type"""
-        return _libBornAgainDevice.vector_longinteger_t_get_allocator(self)
+        r"""get_allocator(vector_longinteger_T self) -> std::vector< unsigned long >::allocator_type"""
+        return _libBornAgainDevice.vector_longinteger_T_get_allocator(self)
 
     def pop_back(self):
-        r"""pop_back(vector_longinteger_t self)"""
-        return _libBornAgainDevice.vector_longinteger_t_pop_back(self)
+        r"""pop_back(vector_longinteger_T self)"""
+        return _libBornAgainDevice.vector_longinteger_T_pop_back(self)
 
     def erase(self, *args):
         r"""
-        erase(vector_longinteger_t self, std::vector< unsigned long >::iterator pos) -> std::vector< unsigned long >::iterator
-        erase(vector_longinteger_t self, std::vector< unsigned long >::iterator first, std::vector< unsigned long >::iterator last) -> std::vector< unsigned long >::iterator
+        erase(vector_longinteger_T self, std::vector< unsigned long >::iterator pos) -> std::vector< unsigned long >::iterator
+        erase(vector_longinteger_T self, std::vector< unsigned long >::iterator first, std::vector< unsigned long >::iterator last) -> std::vector< unsigned long >::iterator
         """
-        return _libBornAgainDevice.vector_longinteger_t_erase(self, *args)
+        return _libBornAgainDevice.vector_longinteger_T_erase(self, *args)
 
     def __init__(self, *args):
         r"""
-        __init__(vector_longinteger_t self) -> vector_longinteger_t
-        __init__(vector_longinteger_t self, vector_longinteger_t other) -> vector_longinteger_t
-        __init__(vector_longinteger_t self, std::vector< unsigned long >::size_type size) -> vector_longinteger_t
-        __init__(vector_longinteger_t self, std::vector< unsigned long >::size_type size, std::vector< unsigned long >::value_type const & value) -> vector_longinteger_t
+        __init__(vector_longinteger_T self) -> vector_longinteger_T
+        __init__(vector_longinteger_T self, vector_longinteger_T other) -> vector_longinteger_T
+        __init__(vector_longinteger_T self, std::vector< unsigned long >::size_type size) -> vector_longinteger_T
+        __init__(vector_longinteger_T self, std::vector< unsigned long >::size_type size, std::vector< unsigned long >::value_type const & value) -> vector_longinteger_T
         """
-        _libBornAgainDevice.vector_longinteger_t_swiginit(self, _libBornAgainDevice.new_vector_longinteger_t(*args))
+        _libBornAgainDevice.vector_longinteger_T_swiginit(self, _libBornAgainDevice.new_vector_longinteger_T(*args))
 
     def push_back(self, x):
-        r"""push_back(vector_longinteger_t self, std::vector< unsigned long >::value_type const & x)"""
-        return _libBornAgainDevice.vector_longinteger_t_push_back(self, x)
+        r"""push_back(vector_longinteger_T self, std::vector< unsigned long >::value_type const & x)"""
+        return _libBornAgainDevice.vector_longinteger_T_push_back(self, x)
 
     def front(self):
-        r"""front(vector_longinteger_t self) -> std::vector< unsigned long >::value_type const &"""
-        return _libBornAgainDevice.vector_longinteger_t_front(self)
+        r"""front(vector_longinteger_T self) -> std::vector< unsigned long >::value_type const &"""
+        return _libBornAgainDevice.vector_longinteger_T_front(self)
 
     def back(self):
-        r"""back(vector_longinteger_t self) -> std::vector< unsigned long >::value_type const &"""
-        return _libBornAgainDevice.vector_longinteger_t_back(self)
+        r"""back(vector_longinteger_T self) -> std::vector< unsigned long >::value_type const &"""
+        return _libBornAgainDevice.vector_longinteger_T_back(self)
 
     def assign(self, n, x):
-        r"""assign(vector_longinteger_t self, std::vector< unsigned long >::size_type n, std::vector< unsigned long >::value_type const & x)"""
-        return _libBornAgainDevice.vector_longinteger_t_assign(self, n, x)
+        r"""assign(vector_longinteger_T self, std::vector< unsigned long >::size_type n, std::vector< unsigned long >::value_type const & x)"""
+        return _libBornAgainDevice.vector_longinteger_T_assign(self, n, x)
 
     def resize(self, *args):
         r"""
-        resize(vector_longinteger_t self, std::vector< unsigned long >::size_type new_size)
-        resize(vector_longinteger_t self, std::vector< unsigned long >::size_type new_size, std::vector< unsigned long >::value_type const & x)
+        resize(vector_longinteger_T self, std::vector< unsigned long >::size_type new_size)
+        resize(vector_longinteger_T self, std::vector< unsigned long >::size_type new_size, std::vector< unsigned long >::value_type const & x)
         """
-        return _libBornAgainDevice.vector_longinteger_t_resize(self, *args)
+        return _libBornAgainDevice.vector_longinteger_T_resize(self, *args)
 
     def insert(self, *args):
         r"""
-        insert(vector_longinteger_t self, std::vector< unsigned long >::iterator pos, std::vector< unsigned long >::value_type const & x) -> std::vector< unsigned long >::iterator
-        insert(vector_longinteger_t self, std::vector< unsigned long >::iterator pos, std::vector< unsigned long >::size_type n, std::vector< unsigned long >::value_type const & x)
+        insert(vector_longinteger_T self, std::vector< unsigned long >::iterator pos, std::vector< unsigned long >::value_type const & x) -> std::vector< unsigned long >::iterator
+        insert(vector_longinteger_T self, std::vector< unsigned long >::iterator pos, std::vector< unsigned long >::size_type n, std::vector< unsigned long >::value_type const & x)
         """
-        return _libBornAgainDevice.vector_longinteger_t_insert(self, *args)
+        return _libBornAgainDevice.vector_longinteger_T_insert(self, *args)
 
     def reserve(self, n):
-        r"""reserve(vector_longinteger_t self, std::vector< unsigned long >::size_type n)"""
-        return _libBornAgainDevice.vector_longinteger_t_reserve(self, n)
+        r"""reserve(vector_longinteger_T self, std::vector< unsigned long >::size_type n)"""
+        return _libBornAgainDevice.vector_longinteger_T_reserve(self, n)
 
     def capacity(self):
-        r"""capacity(vector_longinteger_t self) -> std::vector< unsigned long >::size_type"""
-        return _libBornAgainDevice.vector_longinteger_t_capacity(self)
-    __swig_destroy__ = _libBornAgainDevice.delete_vector_longinteger_t
+        r"""capacity(vector_longinteger_T self) -> std::vector< unsigned long >::size_type"""
+        return _libBornAgainDevice.vector_longinteger_T_capacity(self)
+    __swig_destroy__ = _libBornAgainDevice.delete_vector_longinteger_T
 
-# Register vector_longinteger_t in _libBornAgainDevice:
-_libBornAgainDevice.vector_longinteger_t_swigregister(vector_longinteger_t)
-class vector_complex_t(object):
+# Register vector_longinteger_T in _libBornAgainDevice:
+_libBornAgainDevice.vector_longinteger_T_swigregister(vector_longinteger_T)
+class vector_complex_T(object):
     r"""Proxy of C++ std::vector< std::complex< double > > class."""
 
     thisown = property(lambda x: x.this.own(), lambda x, v: x.this.own(v), doc="The membership flag")
     __repr__ = _swig_repr
 
     def iterator(self):
-        r"""iterator(vector_complex_t self) -> SwigPyIterator"""
-        return _libBornAgainDevice.vector_complex_t_iterator(self)
+        r"""iterator(vector_complex_T self) -> SwigPyIterator"""
+        return _libBornAgainDevice.vector_complex_T_iterator(self)
     def __iter__(self):
         return self.iterator()
 
     def __nonzero__(self):
-        r"""__nonzero__(vector_complex_t self) -> bool"""
-        return _libBornAgainDevice.vector_complex_t___nonzero__(self)
+        r"""__nonzero__(vector_complex_T self) -> bool"""
+        return _libBornAgainDevice.vector_complex_T___nonzero__(self)
 
     def __bool__(self):
-        r"""__bool__(vector_complex_t self) -> bool"""
-        return _libBornAgainDevice.vector_complex_t___bool__(self)
+        r"""__bool__(vector_complex_T self) -> bool"""
+        return _libBornAgainDevice.vector_complex_T___bool__(self)
 
     def __len__(self):
-        r"""__len__(vector_complex_t self) -> std::vector< std::complex< double > >::size_type"""
-        return _libBornAgainDevice.vector_complex_t___len__(self)
+        r"""__len__(vector_complex_T self) -> std::vector< std::complex< double > >::size_type"""
+        return _libBornAgainDevice.vector_complex_T___len__(self)
 
     def __getslice__(self, i, j):
-        r"""__getslice__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j) -> vector_complex_t"""
-        return _libBornAgainDevice.vector_complex_t___getslice__(self, i, j)
+        r"""__getslice__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j) -> vector_complex_T"""
+        return _libBornAgainDevice.vector_complex_T___getslice__(self, i, j)
 
     def __setslice__(self, *args):
         r"""
-        __setslice__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j)
-        __setslice__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j, vector_complex_t v)
+        __setslice__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j)
+        __setslice__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j, vector_complex_T v)
         """
-        return _libBornAgainDevice.vector_complex_t___setslice__(self, *args)
+        return _libBornAgainDevice.vector_complex_T___setslice__(self, *args)
 
     def __delslice__(self, i, j):
-        r"""__delslice__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j)"""
-        return _libBornAgainDevice.vector_complex_t___delslice__(self, i, j)
+        r"""__delslice__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j)"""
+        return _libBornAgainDevice.vector_complex_T___delslice__(self, i, j)
 
     def __delitem__(self, *args):
         r"""
-        __delitem__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i)
-        __delitem__(vector_complex_t self, SWIGPY_SLICEOBJECT * slice)
+        __delitem__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i)
+        __delitem__(vector_complex_T self, SWIGPY_SLICEOBJECT * slice)
         """
-        return _libBornAgainDevice.vector_complex_t___delitem__(self, *args)
+        return _libBornAgainDevice.vector_complex_T___delitem__(self, *args)
 
     def __getitem__(self, *args):
         r"""
-        __getitem__(vector_complex_t self, SWIGPY_SLICEOBJECT * slice) -> vector_complex_t
-        __getitem__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i) -> std::vector< std::complex< double > >::value_type const &
+        __getitem__(vector_complex_T self, SWIGPY_SLICEOBJECT * slice) -> vector_complex_T
+        __getitem__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i) -> std::vector< std::complex< double > >::value_type const &
         """
-        return _libBornAgainDevice.vector_complex_t___getitem__(self, *args)
+        return _libBornAgainDevice.vector_complex_T___getitem__(self, *args)
 
     def __setitem__(self, *args):
         r"""
-        __setitem__(vector_complex_t self, SWIGPY_SLICEOBJECT * slice, vector_complex_t v)
-        __setitem__(vector_complex_t self, SWIGPY_SLICEOBJECT * slice)
-        __setitem__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::value_type const & x)
+        __setitem__(vector_complex_T self, SWIGPY_SLICEOBJECT * slice, vector_complex_T v)
+        __setitem__(vector_complex_T self, SWIGPY_SLICEOBJECT * slice)
+        __setitem__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::value_type const & x)
         """
-        return _libBornAgainDevice.vector_complex_t___setitem__(self, *args)
+        return _libBornAgainDevice.vector_complex_T___setitem__(self, *args)
 
     def pop(self):
-        r"""pop(vector_complex_t self) -> std::vector< std::complex< double > >::value_type"""
-        return _libBornAgainDevice.vector_complex_t_pop(self)
+        r"""pop(vector_complex_T self) -> std::vector< std::complex< double > >::value_type"""
+        return _libBornAgainDevice.vector_complex_T_pop(self)
 
     def append(self, x):
-        r"""append(vector_complex_t self, std::vector< std::complex< double > >::value_type const & x)"""
-        return _libBornAgainDevice.vector_complex_t_append(self, x)
+        r"""append(vector_complex_T self, std::vector< std::complex< double > >::value_type const & x)"""
+        return _libBornAgainDevice.vector_complex_T_append(self, x)
 
     def empty(self):
-        r"""empty(vector_complex_t self) -> bool"""
-        return _libBornAgainDevice.vector_complex_t_empty(self)
+        r"""empty(vector_complex_T self) -> bool"""
+        return _libBornAgainDevice.vector_complex_T_empty(self)
 
     def size(self):
-        r"""size(vector_complex_t self) -> std::vector< std::complex< double > >::size_type"""
-        return _libBornAgainDevice.vector_complex_t_size(self)
+        r"""size(vector_complex_T self) -> std::vector< std::complex< double > >::size_type"""
+        return _libBornAgainDevice.vector_complex_T_size(self)
 
     def swap(self, v):
-        r"""swap(vector_complex_t self, vector_complex_t v)"""
-        return _libBornAgainDevice.vector_complex_t_swap(self, v)
+        r"""swap(vector_complex_T self, vector_complex_T v)"""
+        return _libBornAgainDevice.vector_complex_T_swap(self, v)
 
     def begin(self):
-        r"""begin(vector_complex_t self) -> std::vector< std::complex< double > >::iterator"""
-        return _libBornAgainDevice.vector_complex_t_begin(self)
+        r"""begin(vector_complex_T self) -> std::vector< std::complex< double > >::iterator"""
+        return _libBornAgainDevice.vector_complex_T_begin(self)
 
     def end(self):
-        r"""end(vector_complex_t self) -> std::vector< std::complex< double > >::iterator"""
-        return _libBornAgainDevice.vector_complex_t_end(self)
+        r"""end(vector_complex_T self) -> std::vector< std::complex< double > >::iterator"""
+        return _libBornAgainDevice.vector_complex_T_end(self)
 
     def rbegin(self):
-        r"""rbegin(vector_complex_t self) -> std::vector< std::complex< double > >::reverse_iterator"""
-        return _libBornAgainDevice.vector_complex_t_rbegin(self)
+        r"""rbegin(vector_complex_T self) -> std::vector< std::complex< double > >::reverse_iterator"""
+        return _libBornAgainDevice.vector_complex_T_rbegin(self)
 
     def rend(self):
-        r"""rend(vector_complex_t self) -> std::vector< std::complex< double > >::reverse_iterator"""
-        return _libBornAgainDevice.vector_complex_t_rend(self)
+        r"""rend(vector_complex_T self) -> std::vector< std::complex< double > >::reverse_iterator"""
+        return _libBornAgainDevice.vector_complex_T_rend(self)
 
     def clear(self):
-        r"""clear(vector_complex_t self)"""
-        return _libBornAgainDevice.vector_complex_t_clear(self)
+        r"""clear(vector_complex_T self)"""
+        return _libBornAgainDevice.vector_complex_T_clear(self)
 
     def get_allocator(self):
-        r"""get_allocator(vector_complex_t self) -> std::vector< std::complex< double > >::allocator_type"""
-        return _libBornAgainDevice.vector_complex_t_get_allocator(self)
+        r"""get_allocator(vector_complex_T self) -> std::vector< std::complex< double > >::allocator_type"""
+        return _libBornAgainDevice.vector_complex_T_get_allocator(self)
 
     def pop_back(self):
-        r"""pop_back(vector_complex_t self)"""
-        return _libBornAgainDevice.vector_complex_t_pop_back(self)
+        r"""pop_back(vector_complex_T self)"""
+        return _libBornAgainDevice.vector_complex_T_pop_back(self)
 
     def erase(self, *args):
         r"""
-        erase(vector_complex_t self, std::vector< std::complex< double > >::iterator pos) -> std::vector< std::complex< double > >::iterator
-        erase(vector_complex_t self, std::vector< std::complex< double > >::iterator first, std::vector< std::complex< double > >::iterator last) -> std::vector< std::complex< double > >::iterator
+        erase(vector_complex_T self, std::vector< std::complex< double > >::iterator pos) -> std::vector< std::complex< double > >::iterator
+        erase(vector_complex_T self, std::vector< std::complex< double > >::iterator first, std::vector< std::complex< double > >::iterator last) -> std::vector< std::complex< double > >::iterator
         """
-        return _libBornAgainDevice.vector_complex_t_erase(self, *args)
+        return _libBornAgainDevice.vector_complex_T_erase(self, *args)
 
     def __init__(self, *args):
         r"""
-        __init__(vector_complex_t self) -> vector_complex_t
-        __init__(vector_complex_t self, vector_complex_t other) -> vector_complex_t
-        __init__(vector_complex_t self, std::vector< std::complex< double > >::size_type size) -> vector_complex_t
-        __init__(vector_complex_t self, std::vector< std::complex< double > >::size_type size, std::vector< std::complex< double > >::value_type const & value) -> vector_complex_t
+        __init__(vector_complex_T self) -> vector_complex_T
+        __init__(vector_complex_T self, vector_complex_T other) -> vector_complex_T
+        __init__(vector_complex_T self, std::vector< std::complex< double > >::size_type size) -> vector_complex_T
+        __init__(vector_complex_T self, std::vector< std::complex< double > >::size_type size, std::vector< std::complex< double > >::value_type const & value) -> vector_complex_T
         """
-        _libBornAgainDevice.vector_complex_t_swiginit(self, _libBornAgainDevice.new_vector_complex_t(*args))
+        _libBornAgainDevice.vector_complex_T_swiginit(self, _libBornAgainDevice.new_vector_complex_T(*args))
 
     def push_back(self, x):
-        r"""push_back(vector_complex_t self, std::vector< std::complex< double > >::value_type const & x)"""
-        return _libBornAgainDevice.vector_complex_t_push_back(self, x)
+        r"""push_back(vector_complex_T self, std::vector< std::complex< double > >::value_type const & x)"""
+        return _libBornAgainDevice.vector_complex_T_push_back(self, x)
 
     def front(self):
-        r"""front(vector_complex_t self) -> std::vector< std::complex< double > >::value_type const &"""
-        return _libBornAgainDevice.vector_complex_t_front(self)
+        r"""front(vector_complex_T self) -> std::vector< std::complex< double > >::value_type const &"""
+        return _libBornAgainDevice.vector_complex_T_front(self)
 
     def back(self):
-        r"""back(vector_complex_t self) -> std::vector< std::complex< double > >::value_type const &"""
-        return _libBornAgainDevice.vector_complex_t_back(self)
+        r"""back(vector_complex_T self) -> std::vector< std::complex< double > >::value_type const &"""
+        return _libBornAgainDevice.vector_complex_T_back(self)
 
     def assign(self, n, x):
-        r"""assign(vector_complex_t self, std::vector< std::complex< double > >::size_type n, std::vector< std::complex< double > >::value_type const & x)"""
-        return _libBornAgainDevice.vector_complex_t_assign(self, n, x)
+        r"""assign(vector_complex_T self, std::vector< std::complex< double > >::size_type n, std::vector< std::complex< double > >::value_type const & x)"""
+        return _libBornAgainDevice.vector_complex_T_assign(self, n, x)
 
     def resize(self, *args):
         r"""
-        resize(vector_complex_t self, std::vector< std::complex< double > >::size_type new_size)
-        resize(vector_complex_t self, std::vector< std::complex< double > >::size_type new_size, std::vector< std::complex< double > >::value_type const & x)
+        resize(vector_complex_T self, std::vector< std::complex< double > >::size_type new_size)
+        resize(vector_complex_T self, std::vector< std::complex< double > >::size_type new_size, std::vector< std::complex< double > >::value_type const & x)
         """
-        return _libBornAgainDevice.vector_complex_t_resize(self, *args)
+        return _libBornAgainDevice.vector_complex_T_resize(self, *args)
 
     def insert(self, *args):
         r"""
-        insert(vector_complex_t self, std::vector< std::complex< double > >::iterator pos, std::vector< std::complex< double > >::value_type const & x) -> std::vector< std::complex< double > >::iterator
-        insert(vector_complex_t self, std::vector< std::complex< double > >::iterator pos, std::vector< std::complex< double > >::size_type n, std::vector< std::complex< double > >::value_type const & x)
+        insert(vector_complex_T self, std::vector< std::complex< double > >::iterator pos, std::vector< std::complex< double > >::value_type const & x) -> std::vector< std::complex< double > >::iterator
+        insert(vector_complex_T self, std::vector< std::complex< double > >::iterator pos, std::vector< std::complex< double > >::size_type n, std::vector< std::complex< double > >::value_type const & x)
         """
-        return _libBornAgainDevice.vector_complex_t_insert(self, *args)
+        return _libBornAgainDevice.vector_complex_T_insert(self, *args)
 
     def reserve(self, n):
-        r"""reserve(vector_complex_t self, std::vector< std::complex< double > >::size_type n)"""
-        return _libBornAgainDevice.vector_complex_t_reserve(self, n)
+        r"""reserve(vector_complex_T self, std::vector< std::complex< double > >::size_type n)"""
+        return _libBornAgainDevice.vector_complex_T_reserve(self, n)
 
     def capacity(self):
-        r"""capacity(vector_complex_t self) -> std::vector< std::complex< double > >::size_type"""
-        return _libBornAgainDevice.vector_complex_t_capacity(self)
-    __swig_destroy__ = _libBornAgainDevice.delete_vector_complex_t
+        r"""capacity(vector_complex_T self) -> std::vector< std::complex< double > >::size_type"""
+        return _libBornAgainDevice.vector_complex_T_capacity(self)
+    __swig_destroy__ = _libBornAgainDevice.delete_vector_complex_T
 
-# Register vector_complex_t in _libBornAgainDevice:
-_libBornAgainDevice.vector_complex_t_swigregister(vector_complex_t)
-class vector_string_t(object):
+# Register vector_complex_T in _libBornAgainDevice:
+_libBornAgainDevice.vector_complex_T_swigregister(vector_complex_T)
+class vector_string_T(object):
     r"""Proxy of C++ std::vector< std::string > class."""
 
     thisown = property(lambda x: x.this.own(), lambda x, v: x.this.own(v), doc="The membership flag")
     __repr__ = _swig_repr
 
     def iterator(self):
-        r"""iterator(vector_string_t self) -> SwigPyIterator"""
-        return _libBornAgainDevice.vector_string_t_iterator(self)
+        r"""iterator(vector_string_T self) -> SwigPyIterator"""
+        return _libBornAgainDevice.vector_string_T_iterator(self)
     def __iter__(self):
         return self.iterator()
 
     def __nonzero__(self):
-        r"""__nonzero__(vector_string_t self) -> bool"""
-        return _libBornAgainDevice.vector_string_t___nonzero__(self)
+        r"""__nonzero__(vector_string_T self) -> bool"""
+        return _libBornAgainDevice.vector_string_T___nonzero__(self)
 
     def __bool__(self):
-        r"""__bool__(vector_string_t self) -> bool"""
-        return _libBornAgainDevice.vector_string_t___bool__(self)
+        r"""__bool__(vector_string_T self) -> bool"""
+        return _libBornAgainDevice.vector_string_T___bool__(self)
 
     def __len__(self):
-        r"""__len__(vector_string_t self) -> std::vector< std::string >::size_type"""
-        return _libBornAgainDevice.vector_string_t___len__(self)
+        r"""__len__(vector_string_T self) -> std::vector< std::string >::size_type"""
+        return _libBornAgainDevice.vector_string_T___len__(self)
 
     def __getslice__(self, i, j):
-        r"""__getslice__(vector_string_t self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j) -> vector_string_t"""
-        return _libBornAgainDevice.vector_string_t___getslice__(self, i, j)
+        r"""__getslice__(vector_string_T self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j) -> vector_string_T"""
+        return _libBornAgainDevice.vector_string_T___getslice__(self, i, j)
 
     def __setslice__(self, *args):
         r"""
-        __setslice__(vector_string_t self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j)
-        __setslice__(vector_string_t self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j, vector_string_t v)
+        __setslice__(vector_string_T self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j)
+        __setslice__(vector_string_T self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j, vector_string_T v)
         """
-        return _libBornAgainDevice.vector_string_t___setslice__(self, *args)
+        return _libBornAgainDevice.vector_string_T___setslice__(self, *args)
 
     def __delslice__(self, i, j):
-        r"""__delslice__(vector_string_t self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j)"""
-        return _libBornAgainDevice.vector_string_t___delslice__(self, i, j)
+        r"""__delslice__(vector_string_T self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j)"""
+        return _libBornAgainDevice.vector_string_T___delslice__(self, i, j)
 
     def __delitem__(self, *args):
         r"""
-        __delitem__(vector_string_t self, std::vector< std::string >::difference_type i)
-        __delitem__(vector_string_t self, SWIGPY_SLICEOBJECT * slice)
+        __delitem__(vector_string_T self, std::vector< std::string >::difference_type i)
+        __delitem__(vector_string_T self, SWIGPY_SLICEOBJECT * slice)
         """
-        return _libBornAgainDevice.vector_string_t___delitem__(self, *args)
+        return _libBornAgainDevice.vector_string_T___delitem__(self, *args)
 
     def __getitem__(self, *args):
         r"""
-        __getitem__(vector_string_t self, SWIGPY_SLICEOBJECT * slice) -> vector_string_t
-        __getitem__(vector_string_t self, std::vector< std::string >::difference_type i) -> std::vector< std::string >::value_type const &
+        __getitem__(vector_string_T self, SWIGPY_SLICEOBJECT * slice) -> vector_string_T
+        __getitem__(vector_string_T self, std::vector< std::string >::difference_type i) -> std::vector< std::string >::value_type const &
         """
-        return _libBornAgainDevice.vector_string_t___getitem__(self, *args)
+        return _libBornAgainDevice.vector_string_T___getitem__(self, *args)
 
     def __setitem__(self, *args):
         r"""
-        __setitem__(vector_string_t self, SWIGPY_SLICEOBJECT * slice, vector_string_t v)
-        __setitem__(vector_string_t self, SWIGPY_SLICEOBJECT * slice)
-        __setitem__(vector_string_t self, std::vector< std::string >::difference_type i, std::vector< std::string >::value_type const & x)
+        __setitem__(vector_string_T self, SWIGPY_SLICEOBJECT * slice, vector_string_T v)
+        __setitem__(vector_string_T self, SWIGPY_SLICEOBJECT * slice)
+        __setitem__(vector_string_T self, std::vector< std::string >::difference_type i, std::vector< std::string >::value_type const & x)
         """
-        return _libBornAgainDevice.vector_string_t___setitem__(self, *args)
+        return _libBornAgainDevice.vector_string_T___setitem__(self, *args)
 
     def pop(self):
-        r"""pop(vector_string_t self) -> std::vector< std::string >::value_type"""
-        return _libBornAgainDevice.vector_string_t_pop(self)
+        r"""pop(vector_string_T self) -> std::vector< std::string >::value_type"""
+        return _libBornAgainDevice.vector_string_T_pop(self)
 
     def append(self, x):
-        r"""append(vector_string_t self, std::vector< std::string >::value_type const & x)"""
-        return _libBornAgainDevice.vector_string_t_append(self, x)
+        r"""append(vector_string_T self, std::vector< std::string >::value_type const & x)"""
+        return _libBornAgainDevice.vector_string_T_append(self, x)
 
     def empty(self):
-        r"""empty(vector_string_t self) -> bool"""
-        return _libBornAgainDevice.vector_string_t_empty(self)
+        r"""empty(vector_string_T self) -> bool"""
+        return _libBornAgainDevice.vector_string_T_empty(self)
 
     def size(self):
-        r"""size(vector_string_t self) -> std::vector< std::string >::size_type"""
-        return _libBornAgainDevice.vector_string_t_size(self)
+        r"""size(vector_string_T self) -> std::vector< std::string >::size_type"""
+        return _libBornAgainDevice.vector_string_T_size(self)
 
     def swap(self, v):
-        r"""swap(vector_string_t self, vector_string_t v)"""
-        return _libBornAgainDevice.vector_string_t_swap(self, v)
+        r"""swap(vector_string_T self, vector_string_T v)"""
+        return _libBornAgainDevice.vector_string_T_swap(self, v)
 
     def begin(self):
-        r"""begin(vector_string_t self) -> std::vector< std::string >::iterator"""
-        return _libBornAgainDevice.vector_string_t_begin(self)
+        r"""begin(vector_string_T self) -> std::vector< std::string >::iterator"""
+        return _libBornAgainDevice.vector_string_T_begin(self)
 
     def end(self):
-        r"""end(vector_string_t self) -> std::vector< std::string >::iterator"""
-        return _libBornAgainDevice.vector_string_t_end(self)
+        r"""end(vector_string_T self) -> std::vector< std::string >::iterator"""
+        return _libBornAgainDevice.vector_string_T_end(self)
 
     def rbegin(self):
-        r"""rbegin(vector_string_t self) -> std::vector< std::string >::reverse_iterator"""
-        return _libBornAgainDevice.vector_string_t_rbegin(self)
+        r"""rbegin(vector_string_T self) -> std::vector< std::string >::reverse_iterator"""
+        return _libBornAgainDevice.vector_string_T_rbegin(self)
 
     def rend(self):
-        r"""rend(vector_string_t self) -> std::vector< std::string >::reverse_iterator"""
-        return _libBornAgainDevice.vector_string_t_rend(self)
+        r"""rend(vector_string_T self) -> std::vector< std::string >::reverse_iterator"""
+        return _libBornAgainDevice.vector_string_T_rend(self)
 
     def clear(self):
-        r"""clear(vector_string_t self)"""
-        return _libBornAgainDevice.vector_string_t_clear(self)
+        r"""clear(vector_string_T self)"""
+        return _libBornAgainDevice.vector_string_T_clear(self)
 
     def get_allocator(self):
-        r"""get_allocator(vector_string_t self) -> std::vector< std::string >::allocator_type"""
-        return _libBornAgainDevice.vector_string_t_get_allocator(self)
+        r"""get_allocator(vector_string_T self) -> std::vector< std::string >::allocator_type"""
+        return _libBornAgainDevice.vector_string_T_get_allocator(self)
 
     def pop_back(self):
-        r"""pop_back(vector_string_t self)"""
-        return _libBornAgainDevice.vector_string_t_pop_back(self)
+        r"""pop_back(vector_string_T self)"""
+        return _libBornAgainDevice.vector_string_T_pop_back(self)
 
     def erase(self, *args):
         r"""
-        erase(vector_string_t self, std::vector< std::string >::iterator pos) -> std::vector< std::string >::iterator
-        erase(vector_string_t self, std::vector< std::string >::iterator first, std::vector< std::string >::iterator last) -> std::vector< std::string >::iterator
+        erase(vector_string_T self, std::vector< std::string >::iterator pos) -> std::vector< std::string >::iterator
+        erase(vector_string_T self, std::vector< std::string >::iterator first, std::vector< std::string >::iterator last) -> std::vector< std::string >::iterator
         """
-        return _libBornAgainDevice.vector_string_t_erase(self, *args)
+        return _libBornAgainDevice.vector_string_T_erase(self, *args)
 
     def __init__(self, *args):
         r"""
-        __init__(vector_string_t self) -> vector_string_t
-        __init__(vector_string_t self, vector_string_t other) -> vector_string_t
-        __init__(vector_string_t self, std::vector< std::string >::size_type size) -> vector_string_t
-        __init__(vector_string_t self, std::vector< std::string >::size_type size, std::vector< std::string >::value_type const & value) -> vector_string_t
+        __init__(vector_string_T self) -> vector_string_T
+        __init__(vector_string_T self, vector_string_T other) -> vector_string_T
+        __init__(vector_string_T self, std::vector< std::string >::size_type size) -> vector_string_T
+        __init__(vector_string_T self, std::vector< std::string >::size_type size, std::vector< std::string >::value_type const & value) -> vector_string_T
         """
-        _libBornAgainDevice.vector_string_t_swiginit(self, _libBornAgainDevice.new_vector_string_t(*args))
+        _libBornAgainDevice.vector_string_T_swiginit(self, _libBornAgainDevice.new_vector_string_T(*args))
 
     def push_back(self, x):
-        r"""push_back(vector_string_t self, std::vector< std::string >::value_type const & x)"""
-        return _libBornAgainDevice.vector_string_t_push_back(self, x)
+        r"""push_back(vector_string_T self, std::vector< std::string >::value_type const & x)"""
+        return _libBornAgainDevice.vector_string_T_push_back(self, x)
 
     def front(self):
-        r"""front(vector_string_t self) -> std::vector< std::string >::value_type const &"""
-        return _libBornAgainDevice.vector_string_t_front(self)
+        r"""front(vector_string_T self) -> std::vector< std::string >::value_type const &"""
+        return _libBornAgainDevice.vector_string_T_front(self)
 
     def back(self):
-        r"""back(vector_string_t self) -> std::vector< std::string >::value_type const &"""
-        return _libBornAgainDevice.vector_string_t_back(self)
+        r"""back(vector_string_T self) -> std::vector< std::string >::value_type const &"""
+        return _libBornAgainDevice.vector_string_T_back(self)
 
     def assign(self, n, x):
-        r"""assign(vector_string_t self, std::vector< std::string >::size_type n, std::vector< std::string >::value_type const & x)"""
-        return _libBornAgainDevice.vector_string_t_assign(self, n, x)
+        r"""assign(vector_string_T self, std::vector< std::string >::size_type n, std::vector< std::string >::value_type const & x)"""
+        return _libBornAgainDevice.vector_string_T_assign(self, n, x)
 
     def resize(self, *args):
         r"""
-        resize(vector_string_t self, std::vector< std::string >::size_type new_size)
-        resize(vector_string_t self, std::vector< std::string >::size_type new_size, std::vector< std::string >::value_type const & x)
+        resize(vector_string_T self, std::vector< std::string >::size_type new_size)
+        resize(vector_string_T self, std::vector< std::string >::size_type new_size, std::vector< std::string >::value_type const & x)
         """
-        return _libBornAgainDevice.vector_string_t_resize(self, *args)
+        return _libBornAgainDevice.vector_string_T_resize(self, *args)
 
     def insert(self, *args):
         r"""
-        insert(vector_string_t self, std::vector< std::string >::iterator pos, std::vector< std::string >::value_type const & x) -> std::vector< std::string >::iterator
-        insert(vector_string_t self, std::vector< std::string >::iterator pos, std::vector< std::string >::size_type n, std::vector< std::string >::value_type const & x)
+        insert(vector_string_T self, std::vector< std::string >::iterator pos, std::vector< std::string >::value_type const & x) -> std::vector< std::string >::iterator
+        insert(vector_string_T self, std::vector< std::string >::iterator pos, std::vector< std::string >::size_type n, std::vector< std::string >::value_type const & x)
         """
-        return _libBornAgainDevice.vector_string_t_insert(self, *args)
+        return _libBornAgainDevice.vector_string_T_insert(self, *args)
 
     def reserve(self, n):
-        r"""reserve(vector_string_t self, std::vector< std::string >::size_type n)"""
-        return _libBornAgainDevice.vector_string_t_reserve(self, n)
+        r"""reserve(vector_string_T self, std::vector< std::string >::size_type n)"""
+        return _libBornAgainDevice.vector_string_T_reserve(self, n)
 
     def capacity(self):
-        r"""capacity(vector_string_t self) -> std::vector< std::string >::size_type"""
-        return _libBornAgainDevice.vector_string_t_capacity(self)
-    __swig_destroy__ = _libBornAgainDevice.delete_vector_string_t
+        r"""capacity(vector_string_T self) -> std::vector< std::string >::size_type"""
+        return _libBornAgainDevice.vector_string_T_capacity(self)
+    __swig_destroy__ = _libBornAgainDevice.delete_vector_string_T
 
-# Register vector_string_t in _libBornAgainDevice:
-_libBornAgainDevice.vector_string_t_swigregister(vector_string_t)
-class map_string_double_t(object):
+# Register vector_string_T in _libBornAgainDevice:
+_libBornAgainDevice.vector_string_T_swigregister(vector_string_T)
+class map_string_double_T(object):
     r"""Proxy of C++ std::map< std::string,double > class."""
 
     thisown = property(lambda x: x.this.own(), lambda x, v: x.this.own(v), doc="The membership flag")
     __repr__ = _swig_repr
 
     def iterator(self):
-        r"""iterator(map_string_double_t self) -> SwigPyIterator"""
-        return _libBornAgainDevice.map_string_double_t_iterator(self)
+        r"""iterator(map_string_double_T self) -> SwigPyIterator"""
+        return _libBornAgainDevice.map_string_double_T_iterator(self)
     def __iter__(self):
         return self.iterator()
 
     def __nonzero__(self):
-        r"""__nonzero__(map_string_double_t self) -> bool"""
-        return _libBornAgainDevice.map_string_double_t___nonzero__(self)
+        r"""__nonzero__(map_string_double_T self) -> bool"""
+        return _libBornAgainDevice.map_string_double_T___nonzero__(self)
 
     def __bool__(self):
-        r"""__bool__(map_string_double_t self) -> bool"""
-        return _libBornAgainDevice.map_string_double_t___bool__(self)
+        r"""__bool__(map_string_double_T self) -> bool"""
+        return _libBornAgainDevice.map_string_double_T___bool__(self)
 
     def __len__(self):
-        r"""__len__(map_string_double_t self) -> std::map< std::string,double >::size_type"""
-        return _libBornAgainDevice.map_string_double_t___len__(self)
+        r"""__len__(map_string_double_T self) -> std::map< std::string,double >::size_type"""
+        return _libBornAgainDevice.map_string_double_T___len__(self)
     def __iter__(self):
         return self.key_iterator()
     def iterkeys(self):
@@ -1348,124 +1348,124 @@ class map_string_double_t(object):
         return self.iterator()
 
     def __getitem__(self, key):
-        r"""__getitem__(map_string_double_t self, std::map< std::string,double >::key_type const & key) -> std::map< std::string,double >::mapped_type const &"""
-        return _libBornAgainDevice.map_string_double_t___getitem__(self, key)
+        r"""__getitem__(map_string_double_T self, std::map< std::string,double >::key_type const & key) -> std::map< std::string,double >::mapped_type const &"""
+        return _libBornAgainDevice.map_string_double_T___getitem__(self, key)
 
     def __delitem__(self, key):
-        r"""__delitem__(map_string_double_t self, std::map< std::string,double >::key_type const & key)"""
-        return _libBornAgainDevice.map_string_double_t___delitem__(self, key)
+        r"""__delitem__(map_string_double_T self, std::map< std::string,double >::key_type const & key)"""
+        return _libBornAgainDevice.map_string_double_T___delitem__(self, key)
 
     def has_key(self, key):
-        r"""has_key(map_string_double_t self, std::map< std::string,double >::key_type const & key) -> bool"""
-        return _libBornAgainDevice.map_string_double_t_has_key(self, key)
+        r"""has_key(map_string_double_T self, std::map< std::string,double >::key_type const & key) -> bool"""
+        return _libBornAgainDevice.map_string_double_T_has_key(self, key)
 
     def keys(self):
-        r"""keys(map_string_double_t self) -> PyObject *"""
-        return _libBornAgainDevice.map_string_double_t_keys(self)
+        r"""keys(map_string_double_T self) -> PyObject *"""
+        return _libBornAgainDevice.map_string_double_T_keys(self)
 
     def values(self):
-        r"""values(map_string_double_t self) -> PyObject *"""
-        return _libBornAgainDevice.map_string_double_t_values(self)
+        r"""values(map_string_double_T self) -> PyObject *"""
+        return _libBornAgainDevice.map_string_double_T_values(self)
 
     def items(self):
-        r"""items(map_string_double_t self) -> PyObject *"""
-        return _libBornAgainDevice.map_string_double_t_items(self)
+        r"""items(map_string_double_T self) -> PyObject *"""
+        return _libBornAgainDevice.map_string_double_T_items(self)
 
     def __contains__(self, key):
-        r"""__contains__(map_string_double_t self, std::map< std::string,double >::key_type const & key) -> bool"""
-        return _libBornAgainDevice.map_string_double_t___contains__(self, key)
+        r"""__contains__(map_string_double_T self, std::map< std::string,double >::key_type const & key) -> bool"""
+        return _libBornAgainDevice.map_string_double_T___contains__(self, key)
 
     def key_iterator(self):
-        r"""key_iterator(map_string_double_t self) -> SwigPyIterator"""
-        return _libBornAgainDevice.map_string_double_t_key_iterator(self)
+        r"""key_iterator(map_string_double_T self) -> SwigPyIterator"""
+        return _libBornAgainDevice.map_string_double_T_key_iterator(self)
 
     def value_iterator(self):
-        r"""value_iterator(map_string_double_t self) -> SwigPyIterator"""
-        return _libBornAgainDevice.map_string_double_t_value_iterator(self)
+        r"""value_iterator(map_string_double_T self) -> SwigPyIterator"""
+        return _libBornAgainDevice.map_string_double_T_value_iterator(self)
 
     def __setitem__(self, *args):
         r"""
-        __setitem__(map_string_double_t self, std::map< std::string,double >::key_type const & key)
-        __setitem__(map_string_double_t self, std::map< std::string,double >::key_type const & key, std::map< std::string,double >::mapped_type const & x)
+        __setitem__(map_string_double_T self, std::map< std::string,double >::key_type const & key)
+        __setitem__(map_string_double_T self, std::map< std::string,double >::key_type const & key, std::map< std::string,double >::mapped_type const & x)
         """
-        return _libBornAgainDevice.map_string_double_t___setitem__(self, *args)
+        return _libBornAgainDevice.map_string_double_T___setitem__(self, *args)
 
     def asdict(self):
-        r"""asdict(map_string_double_t self) -> PyObject *"""
-        return _libBornAgainDevice.map_string_double_t_asdict(self)
+        r"""asdict(map_string_double_T self) -> PyObject *"""
+        return _libBornAgainDevice.map_string_double_T_asdict(self)
 
     def __init__(self, *args):
         r"""
-        __init__(map_string_double_t self, std::less< std::string > const & other) -> map_string_double_t
-        __init__(map_string_double_t self) -> map_string_double_t
-        __init__(map_string_double_t self, map_string_double_t other) -> map_string_double_t
+        __init__(map_string_double_T self, std::less< std::string > const & other) -> map_string_double_T
+        __init__(map_string_double_T self) -> map_string_double_T
+        __init__(map_string_double_T self, map_string_double_T other) -> map_string_double_T
         """
-        _libBornAgainDevice.map_string_double_t_swiginit(self, _libBornAgainDevice.new_map_string_double_t(*args))
+        _libBornAgainDevice.map_string_double_T_swiginit(self, _libBornAgainDevice.new_map_string_double_T(*args))
 
     def empty(self):
-        r"""empty(map_string_double_t self) -> bool"""
-        return _libBornAgainDevice.map_string_double_t_empty(self)
+        r"""empty(map_string_double_T self) -> bool"""
+        return _libBornAgainDevice.map_string_double_T_empty(self)
 
     def size(self):
-        r"""size(map_string_double_t self) -> std::map< std::string,double >::size_type"""
-        return _libBornAgainDevice.map_string_double_t_size(self)
+        r"""size(map_string_double_T self) -> std::map< std::string,double >::size_type"""
+        return _libBornAgainDevice.map_string_double_T_size(self)
 
     def swap(self, v):
-        r"""swap(map_string_double_t self, map_string_double_t v)"""
-        return _libBornAgainDevice.map_string_double_t_swap(self, v)
+        r"""swap(map_string_double_T self, map_string_double_T v)"""
+        return _libBornAgainDevice.map_string_double_T_swap(self, v)
 
     def begin(self):
-        r"""begin(map_string_double_t self) -> std::map< std::string,double >::iterator"""
-        return _libBornAgainDevice.map_string_double_t_begin(self)
+        r"""begin(map_string_double_T self) -> std::map< std::string,double >::iterator"""
+        return _libBornAgainDevice.map_string_double_T_begin(self)
 
     def end(self):
-        r"""end(map_string_double_t self) -> std::map< std::string,double >::iterator"""
-        return _libBornAgainDevice.map_string_double_t_end(self)
+        r"""end(map_string_double_T self) -> std::map< std::string,double >::iterator"""
+        return _libBornAgainDevice.map_string_double_T_end(self)
 
     def rbegin(self):
-        r"""rbegin(map_string_double_t self) -> std::map< std::string,double >::reverse_iterator"""
-        return _libBornAgainDevice.map_string_double_t_rbegin(self)
+        r"""rbegin(map_string_double_T self) -> std::map< std::string,double >::reverse_iterator"""
+        return _libBornAgainDevice.map_string_double_T_rbegin(self)
 
     def rend(self):
-        r"""rend(map_string_double_t self) -> std::map< std::string,double >::reverse_iterator"""
-        return _libBornAgainDevice.map_string_double_t_rend(self)
+        r"""rend(map_string_double_T self) -> std::map< std::string,double >::reverse_iterator"""
+        return _libBornAgainDevice.map_string_double_T_rend(self)
 
     def clear(self):
-        r"""clear(map_string_double_t self)"""
-        return _libBornAgainDevice.map_string_double_t_clear(self)
+        r"""clear(map_string_double_T self)"""
+        return _libBornAgainDevice.map_string_double_T_clear(self)
 
     def get_allocator(self):
-        r"""get_allocator(map_string_double_t self) -> std::map< std::string,double >::allocator_type"""
-        return _libBornAgainDevice.map_string_double_t_get_allocator(self)
+        r"""get_allocator(map_string_double_T self) -> std::map< std::string,double >::allocator_type"""
+        return _libBornAgainDevice.map_string_double_T_get_allocator(self)
 
     def count(self, x):
-        r"""count(map_string_double_t self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::size_type"""
-        return _libBornAgainDevice.map_string_double_t_count(self, x)
+        r"""count(map_string_double_T self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::size_type"""
+        return _libBornAgainDevice.map_string_double_T_count(self, x)
 
     def erase(self, *args):
         r"""
-        erase(map_string_double_t self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::size_type
-        erase(map_string_double_t self, std::map< std::string,double >::iterator position)
-        erase(map_string_double_t self, std::map< std::string,double >::iterator first, std::map< std::string,double >::iterator last)
+        erase(map_string_double_T self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::size_type
+        erase(map_string_double_T self, std::map< std::string,double >::iterator position)
+        erase(map_string_double_T self, std::map< std::string,double >::iterator first, std::map< std::string,double >::iterator last)
         """
-        return _libBornAgainDevice.map_string_double_t_erase(self, *args)
+        return _libBornAgainDevice.map_string_double_T_erase(self, *args)
 
     def find(self, x):
-        r"""find(map_string_double_t self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"""
-        return _libBornAgainDevice.map_string_double_t_find(self, x)
+        r"""find(map_string_double_T self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"""
+        return _libBornAgainDevice.map_string_double_T_find(self, x)
 
     def lower_bound(self, x):
-        r"""lower_bound(map_string_double_t self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"""
-        return _libBornAgainDevice.map_string_double_t_lower_bound(self, x)
+        r"""lower_bound(map_string_double_T self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"""
+        return _libBornAgainDevice.map_string_double_T_lower_bound(self, x)
 
     def upper_bound(self, x):
-        r"""upper_bound(map_string_double_t self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"""
-        return _libBornAgainDevice.map_string_double_t_upper_bound(self, x)
-    __swig_destroy__ = _libBornAgainDevice.delete_map_string_double_t
+        r"""upper_bound(map_string_double_T self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"""
+        return _libBornAgainDevice.map_string_double_T_upper_bound(self, x)
+    __swig_destroy__ = _libBornAgainDevice.delete_map_string_double_T
 
-# Register map_string_double_t in _libBornAgainDevice:
-_libBornAgainDevice.map_string_double_t_swigregister(map_string_double_t)
-class pvacuum_double_t(object):
+# Register map_string_double_T in _libBornAgainDevice:
+_libBornAgainDevice.map_string_double_T_swigregister(map_string_double_T)
+class pvacuum_double_T(object):
     r"""Proxy of C++ std::pair< double,double > class."""
 
     thisown = property(lambda x: x.this.own(), lambda x, v: x.this.own(v), doc="The membership flag")
@@ -1473,13 +1473,13 @@ class pvacuum_double_t(object):
 
     def __init__(self, *args):
         r"""
-        __init__(pvacuum_double_t self) -> pvacuum_double_t
-        __init__(pvacuum_double_t self, double first, double second) -> pvacuum_double_t
-        __init__(pvacuum_double_t self, pvacuum_double_t other) -> pvacuum_double_t
+        __init__(pvacuum_double_T self) -> pvacuum_double_T
+        __init__(pvacuum_double_T self, double first, double second) -> pvacuum_double_T
+        __init__(pvacuum_double_T self, pvacuum_double_T other) -> pvacuum_double_T
         """
-        _libBornAgainDevice.pvacuum_double_t_swiginit(self, _libBornAgainDevice.new_pvacuum_double_t(*args))
-    first = property(_libBornAgainDevice.pvacuum_double_t_first_get, _libBornAgainDevice.pvacuum_double_t_first_set, doc=r"""first : double""")
-    second = property(_libBornAgainDevice.pvacuum_double_t_second_get, _libBornAgainDevice.pvacuum_double_t_second_set, doc=r"""second : double""")
+        _libBornAgainDevice.pvacuum_double_T_swiginit(self, _libBornAgainDevice.new_pvacuum_double_T(*args))
+    first = property(_libBornAgainDevice.pvacuum_double_T_first_get, _libBornAgainDevice.pvacuum_double_T_first_set, doc=r"""first : double""")
+    second = property(_libBornAgainDevice.pvacuum_double_T_second_get, _libBornAgainDevice.pvacuum_double_T_second_set, doc=r"""second : double""")
     def __len__(self):
         return 2
     def __repr__(self):
@@ -1494,176 +1494,176 @@ class pvacuum_double_t(object):
             self.first = val
         else:
             self.second = val
-    __swig_destroy__ = _libBornAgainDevice.delete_pvacuum_double_t
+    __swig_destroy__ = _libBornAgainDevice.delete_pvacuum_double_T
 
-# Register pvacuum_double_t in _libBornAgainDevice:
-_libBornAgainDevice.pvacuum_double_t_swigregister(pvacuum_double_t)
-class vector_pvacuum_double_t(object):
+# Register pvacuum_double_T in _libBornAgainDevice:
+_libBornAgainDevice.pvacuum_double_T_swigregister(pvacuum_double_T)
+class vector_pvacuum_double_T(object):
     r"""Proxy of C++ std::vector< std::pair< double,double > > class."""
 
     thisown = property(lambda x: x.this.own(), lambda x, v: x.this.own(v), doc="The membership flag")
     __repr__ = _swig_repr
 
     def iterator(self):
-        r"""iterator(vector_pvacuum_double_t self) -> SwigPyIterator"""
-        return _libBornAgainDevice.vector_pvacuum_double_t_iterator(self)
+        r"""iterator(vector_pvacuum_double_T self) -> SwigPyIterator"""
+        return _libBornAgainDevice.vector_pvacuum_double_T_iterator(self)
     def __iter__(self):
         return self.iterator()
 
     def __nonzero__(self):
-        r"""__nonzero__(vector_pvacuum_double_t self) -> bool"""
-        return _libBornAgainDevice.vector_pvacuum_double_t___nonzero__(self)
+        r"""__nonzero__(vector_pvacuum_double_T self) -> bool"""
+        return _libBornAgainDevice.vector_pvacuum_double_T___nonzero__(self)
 
     def __bool__(self):
-        r"""__bool__(vector_pvacuum_double_t self) -> bool"""
-        return _libBornAgainDevice.vector_pvacuum_double_t___bool__(self)
+        r"""__bool__(vector_pvacuum_double_T self) -> bool"""
+        return _libBornAgainDevice.vector_pvacuum_double_T___bool__(self)
 
     def __len__(self):
-        r"""__len__(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::size_type"""
-        return _libBornAgainDevice.vector_pvacuum_double_t___len__(self)
+        r"""__len__(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::size_type"""
+        return _libBornAgainDevice.vector_pvacuum_double_T___len__(self)
 
     def __getslice__(self, i, j):
-        r"""__getslice__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j) -> vector_pvacuum_double_t"""
-        return _libBornAgainDevice.vector_pvacuum_double_t___getslice__(self, i, j)
+        r"""__getslice__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j) -> vector_pvacuum_double_T"""
+        return _libBornAgainDevice.vector_pvacuum_double_T___getslice__(self, i, j)
 
     def __setslice__(self, *args):
         r"""
-        __setslice__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j)
-        __setslice__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j, vector_pvacuum_double_t v)
+        __setslice__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j)
+        __setslice__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j, vector_pvacuum_double_T v)
         """
-        return _libBornAgainDevice.vector_pvacuum_double_t___setslice__(self, *args)
+        return _libBornAgainDevice.vector_pvacuum_double_T___setslice__(self, *args)
 
     def __delslice__(self, i, j):
-        r"""__delslice__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j)"""
-        return _libBornAgainDevice.vector_pvacuum_double_t___delslice__(self, i, j)
+        r"""__delslice__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j)"""
+        return _libBornAgainDevice.vector_pvacuum_double_T___delslice__(self, i, j)
 
     def __delitem__(self, *args):
         r"""
-        __delitem__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i)
-        __delitem__(vector_pvacuum_double_t self, SWIGPY_SLICEOBJECT * slice)
+        __delitem__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i)
+        __delitem__(vector_pvacuum_double_T self, SWIGPY_SLICEOBJECT * slice)
         """
-        return _libBornAgainDevice.vector_pvacuum_double_t___delitem__(self, *args)
+        return _libBornAgainDevice.vector_pvacuum_double_T___delitem__(self, *args)
 
     def __getitem__(self, *args):
         r"""
-        __getitem__(vector_pvacuum_double_t self, SWIGPY_SLICEOBJECT * slice) -> vector_pvacuum_double_t
-        __getitem__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i) -> pvacuum_double_t
+        __getitem__(vector_pvacuum_double_T self, SWIGPY_SLICEOBJECT * slice) -> vector_pvacuum_double_T
+        __getitem__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i) -> pvacuum_double_T
         """
-        return _libBornAgainDevice.vector_pvacuum_double_t___getitem__(self, *args)
+        return _libBornAgainDevice.vector_pvacuum_double_T___getitem__(self, *args)
 
     def __setitem__(self, *args):
         r"""
-        __setitem__(vector_pvacuum_double_t self, SWIGPY_SLICEOBJECT * slice, vector_pvacuum_double_t v)
-        __setitem__(vector_pvacuum_double_t self, SWIGPY_SLICEOBJECT * slice)
-        __setitem__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i, pvacuum_double_t x)
+        __setitem__(vector_pvacuum_double_T self, SWIGPY_SLICEOBJECT * slice, vector_pvacuum_double_T v)
+        __setitem__(vector_pvacuum_double_T self, SWIGPY_SLICEOBJECT * slice)
+        __setitem__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i, pvacuum_double_T x)
         """
-        return _libBornAgainDevice.vector_pvacuum_double_t___setitem__(self, *args)
+        return _libBornAgainDevice.vector_pvacuum_double_T___setitem__(self, *args)
 
     def pop(self):
-        r"""pop(vector_pvacuum_double_t self) -> pvacuum_double_t"""
-        return _libBornAgainDevice.vector_pvacuum_double_t_pop(self)
+        r"""pop(vector_pvacuum_double_T self) -> pvacuum_double_T"""
+        return _libBornAgainDevice.vector_pvacuum_double_T_pop(self)
 
     def append(self, x):
-        r"""append(vector_pvacuum_double_t self, pvacuum_double_t x)"""
-        return _libBornAgainDevice.vector_pvacuum_double_t_append(self, x)
+        r"""append(vector_pvacuum_double_T self, pvacuum_double_T x)"""
+        return _libBornAgainDevice.vector_pvacuum_double_T_append(self, x)
 
     def empty(self):
-        r"""empty(vector_pvacuum_double_t self) -> bool"""
-        return _libBornAgainDevice.vector_pvacuum_double_t_empty(self)
+        r"""empty(vector_pvacuum_double_T self) -> bool"""
+        return _libBornAgainDevice.vector_pvacuum_double_T_empty(self)
 
     def size(self):
-        r"""size(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::size_type"""
-        return _libBornAgainDevice.vector_pvacuum_double_t_size(self)
+        r"""size(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::size_type"""
+        return _libBornAgainDevice.vector_pvacuum_double_T_size(self)
 
     def swap(self, v):
-        r"""swap(vector_pvacuum_double_t self, vector_pvacuum_double_t v)"""
-        return _libBornAgainDevice.vector_pvacuum_double_t_swap(self, v)
+        r"""swap(vector_pvacuum_double_T self, vector_pvacuum_double_T v)"""
+        return _libBornAgainDevice.vector_pvacuum_double_T_swap(self, v)
 
     def begin(self):
-        r"""begin(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::iterator"""
-        return _libBornAgainDevice.vector_pvacuum_double_t_begin(self)
+        r"""begin(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::iterator"""
+        return _libBornAgainDevice.vector_pvacuum_double_T_begin(self)
 
     def end(self):
-        r"""end(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::iterator"""
-        return _libBornAgainDevice.vector_pvacuum_double_t_end(self)
+        r"""end(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::iterator"""
+        return _libBornAgainDevice.vector_pvacuum_double_T_end(self)
 
     def rbegin(self):
-        r"""rbegin(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::reverse_iterator"""
-        return _libBornAgainDevice.vector_pvacuum_double_t_rbegin(self)
+        r"""rbegin(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::reverse_iterator"""
+        return _libBornAgainDevice.vector_pvacuum_double_T_rbegin(self)
 
     def rend(self):
-        r"""rend(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::reverse_iterator"""
-        return _libBornAgainDevice.vector_pvacuum_double_t_rend(self)
+        r"""rend(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::reverse_iterator"""
+        return _libBornAgainDevice.vector_pvacuum_double_T_rend(self)
 
     def clear(self):
-        r"""clear(vector_pvacuum_double_t self)"""
-        return _libBornAgainDevice.vector_pvacuum_double_t_clear(self)
+        r"""clear(vector_pvacuum_double_T self)"""
+        return _libBornAgainDevice.vector_pvacuum_double_T_clear(self)
 
     def get_allocator(self):
-        r"""get_allocator(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::allocator_type"""
-        return _libBornAgainDevice.vector_pvacuum_double_t_get_allocator(self)
+        r"""get_allocator(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::allocator_type"""
+        return _libBornAgainDevice.vector_pvacuum_double_T_get_allocator(self)
 
     def pop_back(self):
-        r"""pop_back(vector_pvacuum_double_t self)"""
-        return _libBornAgainDevice.vector_pvacuum_double_t_pop_back(self)
+        r"""pop_back(vector_pvacuum_double_T self)"""
+        return _libBornAgainDevice.vector_pvacuum_double_T_pop_back(self)
 
     def erase(self, *args):
         r"""
-        erase(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::iterator pos) -> std::vector< std::pair< double,double > >::iterator
-        erase(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::iterator first, std::vector< std::pair< double,double > >::iterator last) -> std::vector< std::pair< double,double > >::iterator
+        erase(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::iterator pos) -> std::vector< std::pair< double,double > >::iterator
+        erase(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::iterator first, std::vector< std::pair< double,double > >::iterator last) -> std::vector< std::pair< double,double > >::iterator
         """
-        return _libBornAgainDevice.vector_pvacuum_double_t_erase(self, *args)
+        return _libBornAgainDevice.vector_pvacuum_double_T_erase(self, *args)
 
     def __init__(self, *args):
         r"""
-        __init__(vector_pvacuum_double_t self) -> vector_pvacuum_double_t
-        __init__(vector_pvacuum_double_t self, vector_pvacuum_double_t other) -> vector_pvacuum_double_t
-        __init__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::size_type size) -> vector_pvacuum_double_t
-        __init__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::size_type size, pvacuum_double_t value) -> vector_pvacuum_double_t
+        __init__(vector_pvacuum_double_T self) -> vector_pvacuum_double_T
+        __init__(vector_pvacuum_double_T self, vector_pvacuum_double_T other) -> vector_pvacuum_double_T
+        __init__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::size_type size) -> vector_pvacuum_double_T
+        __init__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::size_type size, pvacuum_double_T value) -> vector_pvacuum_double_T
         """
-        _libBornAgainDevice.vector_pvacuum_double_t_swiginit(self, _libBornAgainDevice.new_vector_pvacuum_double_t(*args))
+        _libBornAgainDevice.vector_pvacuum_double_T_swiginit(self, _libBornAgainDevice.new_vector_pvacuum_double_T(*args))
 
     def push_back(self, x):
-        r"""push_back(vector_pvacuum_double_t self, pvacuum_double_t x)"""
-        return _libBornAgainDevice.vector_pvacuum_double_t_push_back(self, x)
+        r"""push_back(vector_pvacuum_double_T self, pvacuum_double_T x)"""
+        return _libBornAgainDevice.vector_pvacuum_double_T_push_back(self, x)
 
     def front(self):
-        r"""front(vector_pvacuum_double_t self) -> pvacuum_double_t"""
-        return _libBornAgainDevice.vector_pvacuum_double_t_front(self)
+        r"""front(vector_pvacuum_double_T self) -> pvacuum_double_T"""
+        return _libBornAgainDevice.vector_pvacuum_double_T_front(self)
 
     def back(self):
-        r"""back(vector_pvacuum_double_t self) -> pvacuum_double_t"""
-        return _libBornAgainDevice.vector_pvacuum_double_t_back(self)
+        r"""back(vector_pvacuum_double_T self) -> pvacuum_double_T"""
+        return _libBornAgainDevice.vector_pvacuum_double_T_back(self)
 
     def assign(self, n, x):
-        r"""assign(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::size_type n, pvacuum_double_t x)"""
-        return _libBornAgainDevice.vector_pvacuum_double_t_assign(self, n, x)
+        r"""assign(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::size_type n, pvacuum_double_T x)"""
+        return _libBornAgainDevice.vector_pvacuum_double_T_assign(self, n, x)
 
     def resize(self, *args):
         r"""
-        resize(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::size_type new_size)
-        resize(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::size_type new_size, pvacuum_double_t x)
+        resize(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::size_type new_size)
+        resize(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::size_type new_size, pvacuum_double_T x)
         """
-        return _libBornAgainDevice.vector_pvacuum_double_t_resize(self, *args)
+        return _libBornAgainDevice.vector_pvacuum_double_T_resize(self, *args)
 
     def insert(self, *args):
         r"""
-        insert(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::iterator pos, pvacuum_double_t x) -> std::vector< std::pair< double,double > >::iterator
-        insert(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::iterator pos, std::vector< std::pair< double,double > >::size_type n, pvacuum_double_t x)
+        insert(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::iterator pos, pvacuum_double_T x) -> std::vector< std::pair< double,double > >::iterator
+        insert(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::iterator pos, std::vector< std::pair< double,double > >::size_type n, pvacuum_double_T x)
         """
-        return _libBornAgainDevice.vector_pvacuum_double_t_insert(self, *args)
+        return _libBornAgainDevice.vector_pvacuum_double_T_insert(self, *args)
 
     def reserve(self, n):
-        r"""reserve(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::size_type n)"""
-        return _libBornAgainDevice.vector_pvacuum_double_t_reserve(self, n)
+        r"""reserve(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::size_type n)"""
+        return _libBornAgainDevice.vector_pvacuum_double_T_reserve(self, n)
 
     def capacity(self):
-        r"""capacity(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::size_type"""
-        return _libBornAgainDevice.vector_pvacuum_double_t_capacity(self)
-    __swig_destroy__ = _libBornAgainDevice.delete_vector_pvacuum_double_t
+        r"""capacity(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::size_type"""
+        return _libBornAgainDevice.vector_pvacuum_double_T_capacity(self)
+    __swig_destroy__ = _libBornAgainDevice.delete_vector_pvacuum_double_T
 
-# Register vector_pvacuum_double_t in _libBornAgainDevice:
-_libBornAgainDevice.vector_pvacuum_double_t_swigregister(vector_pvacuum_double_t)
+# Register vector_pvacuum_double_T in _libBornAgainDevice:
+_libBornAgainDevice.vector_pvacuum_double_T_swigregister(vector_pvacuum_double_T)
 import libBornAgainFit
 import libBornAgainBase
 class R3(object):
@@ -2074,13 +2074,13 @@ class Datafield(object):
 
     def __init__(self, *args):
         r"""
-        __init__(Datafield self, std::string const & title, Frame frame, vdouble1d_t values, vdouble1d_t errSigmas={}) -> Datafield
+        __init__(Datafield self, std::string const & title, Frame frame, vdouble1d_T values, vdouble1d_T errSigmas={}) -> Datafield
         __init__(Datafield self, std::string const & title, Frame frame) -> Datafield
-        __init__(Datafield self, Frame frame, vdouble1d_t values, vdouble1d_t errSigmas={}) -> Datafield
+        __init__(Datafield self, Frame frame, vdouble1d_T values, vdouble1d_T errSigmas={}) -> Datafield
         __init__(Datafield self, Frame frame) -> Datafield
-        __init__(Datafield self, std::vector< Scale const *,std::allocator< Scale const * > > const & axes, vdouble1d_t values, vdouble1d_t errSigmas={}) -> Datafield
+        __init__(Datafield self, std::vector< Scale const *,std::allocator< Scale const * > > const & axes, vdouble1d_T values, vdouble1d_T errSigmas={}) -> Datafield
         __init__(Datafield self, std::vector< Scale const *,std::allocator< Scale const * > > const & axes) -> Datafield
-        __init__(Datafield self, std::string const & xlabel, std::string const & ylabel, vdouble2d_t vec) -> Datafield
+        __init__(Datafield self, std::string const & xlabel, std::string const & ylabel, double2d_t const & vec) -> Datafield
         __init__(Datafield self, Datafield arg2) -> Datafield
         """
         _libBornAgainDevice.Datafield_swiginit(self, _libBornAgainDevice.new_Datafield(*args))
@@ -2147,7 +2147,7 @@ class Datafield(object):
         return _libBornAgainDevice.Datafield_empty(self)
 
     def flatVector(self):
-        r"""flatVector(Datafield self) -> vdouble1d_t"""
+        r"""flatVector(Datafield self) -> vdouble1d_T"""
         return _libBornAgainDevice.Datafield_flatVector(self)
 
     def maxVal(self):
@@ -2214,7 +2214,7 @@ class Datafield(object):
         return _libBornAgainDevice.Datafield_setAllTo(self, value)
 
     def errorSigmas(self):
-        r"""errorSigmas(Datafield self) -> vdouble1d_t"""
+        r"""errorSigmas(Datafield self) -> vdouble1d_T"""
         return _libBornAgainDevice.Datafield_errorSigmas(self)
 
 # Register Datafield in _libBornAgainDevice:
@@ -2288,7 +2288,7 @@ class FootprintGauss(IFootprint):
 
     def __init__(self, *args):
         r"""
-        __init__(FootprintGauss self, vdouble1d_t P) -> FootprintGauss
+        __init__(FootprintGauss self, vdouble1d_T P) -> FootprintGauss
         __init__(FootprintGauss self, double width_ratio) -> FootprintGauss
         """
         _libBornAgainDevice.FootprintGauss_swiginit(self, _libBornAgainDevice.new_FootprintGauss(*args))
@@ -2316,7 +2316,7 @@ class FootprintSquare(IFootprint):
 
     def __init__(self, *args):
         r"""
-        __init__(FootprintSquare self, vdouble1d_t P) -> FootprintSquare
+        __init__(FootprintSquare self, vdouble1d_T P) -> FootprintSquare
         __init__(FootprintSquare self, double width_ratio) -> FootprintSquare
         """
         _libBornAgainDevice.FootprintSquare_swiginit(self, _libBornAgainDevice.new_FootprintSquare(*args))
@@ -2491,7 +2491,7 @@ class Polygon(IShape2D):
 
     def __init__(self, *args):
         r"""
-        __init__(Polygon self, vector_pvacuum_double_t points) -> Polygon
+        __init__(Polygon self, vector_pvacuum_double_T points) -> Polygon
         __init__(Polygon self, PolygonPrivate const * d) -> Polygon
         """
         _libBornAgainDevice.Polygon_swiginit(self, _libBornAgainDevice.new_Polygon(*args))
@@ -2513,7 +2513,7 @@ class Polygon(IShape2D):
         return _libBornAgainDevice.Polygon_getArea(self)
 
     def getPoints(self, xpos, ypos):
-        r"""getPoints(Polygon self, vdouble1d_t xpos, vdouble1d_t ypos)"""
+        r"""getPoints(Polygon self, vdouble1d_T xpos, vdouble1d_T ypos)"""
         return _libBornAgainDevice.Polygon_getPoints(self, xpos, ypos)
 
 # Register Polygon in _libBornAgainDevice:
@@ -2789,7 +2789,7 @@ class OffspecDetector(libBornAgainParam.INode):
 _libBornAgainDevice.OffspecDetector_swigregister(OffspecDetector)
 
 def checkRelVecDifference(dat, ref, threshold):
-    r"""checkRelVecDifference(vdouble1d_t dat, vdouble1d_t ref, double threshold) -> bool"""
+    r"""checkRelVecDifference(vdouble1d_T dat, vdouble1d_T ref, double threshold) -> bool"""
     return _libBornAgainDevice.checkRelVecDifference(dat, ref, threshold)
 
 def checkRelativeDifference(dat, ref, threshold):
@@ -2890,5 +2890,5 @@ def dataMatchesFile(data, refFileName, tol):
     return _libBornAgainDevice.dataMatchesFile(data, refFileName, tol)
 
 def FindPeaks(*args):
-    r"""FindPeaks(Datafield data, double sigma=2, std::string const & option={}, double threshold=0.05) -> vector_pvacuum_double_t"""
+    r"""FindPeaks(Datafield data, double sigma=2, std::string const & option={}, double threshold=0.05) -> vector_pvacuum_double_T"""
     return _libBornAgainDevice.FindPeaks(*args)
diff --git a/auto/Wrap/libBornAgainDevice_wrap.cpp b/auto/Wrap/libBornAgainDevice_wrap.cpp
index a80054b35971f6da1696e60615b60f70db73cc3c..6353e544fcf4d2952f7c8dd559d9e46099377e8a 100644
--- a/auto/Wrap/libBornAgainDevice_wrap.cpp
+++ b/auto/Wrap/libBornAgainDevice_wrap.cpp
@@ -3682,8 +3682,8 @@ namespace Swig {
 #define SWIGTYPE_p_allocator_type swig_types[34]
 #define SWIGTYPE_p_char swig_types[35]
 #define SWIGTYPE_p_const_iterator swig_types[36]
-#define SWIGTYPE_p_corr_matrix_t swig_types[37]
-#define SWIGTYPE_p_difference_type swig_types[38]
+#define SWIGTYPE_p_difference_type swig_types[37]
+#define SWIGTYPE_p_double2d_t swig_types[38]
 #define SWIGTYPE_p_first_type swig_types[39]
 #define SWIGTYPE_p_int swig_types[40]
 #define SWIGTYPE_p_iterator swig_types[41]
@@ -8047,7 +8047,7 @@ SWIGINTERN PyObject *SwigPyIterator_swigregister(PyObject *SWIGUNUSEDPARM(self),
   return SWIG_Py_Void();
 }
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_iterator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_iterator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   PyObject **arg2 = (PyObject **) 0 ;
@@ -8062,7 +8062,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_iterator(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_iterator" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_iterator" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = (swig::SwigPyIterator *)std_vector_Sl_double_Sg__iterator(arg1,arg2);
@@ -8073,7 +8073,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___nonzero__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___nonzero__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -8086,7 +8086,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___nonzero__(PyObject *self, PyObject *arg
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___nonzero__" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___nonzero__" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = (bool)std_vector_Sl_double_Sg____nonzero__((std::vector< double > const *)arg1);
@@ -8097,7 +8097,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___bool__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___bool__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -8110,7 +8110,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___bool__(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___bool__" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___bool__" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = (bool)std_vector_Sl_double_Sg____bool__((std::vector< double > const *)arg1);
@@ -8121,7 +8121,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___len__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___len__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -8134,7 +8134,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___len__(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___len__" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___len__" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = std_vector_Sl_double_Sg____len__((std::vector< double > const *)arg1);
@@ -8145,7 +8145,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___getslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___getslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::difference_type arg2 ;
@@ -8160,20 +8160,20 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___getslice__(PyObject *self, PyObject *ar
   std::vector< double,std::allocator< double > > *result = 0 ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_t___getslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_T___getslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___getslice__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___getslice__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t___getslice__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T___getslice__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< double >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_t___getslice__" "', argument " "3"" of type '" "std::vector< double >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_T___getslice__" "', argument " "3"" of type '" "std::vector< double >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< double >::difference_type >(val3);
   try {
@@ -8190,7 +8190,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::difference_type arg2 ;
@@ -8206,17 +8206,17 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setslice____SWIG_0(PyObject *self, Py_s
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___setslice__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___setslice__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t___setslice__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T___setslice__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< double >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_t___setslice__" "', argument " "3"" of type '" "std::vector< double >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_T___setslice__" "', argument " "3"" of type '" "std::vector< double >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< double >::difference_type >(val3);
   try {
@@ -8233,7 +8233,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::difference_type arg2 ;
@@ -8251,27 +8251,27 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setslice____SWIG_1(PyObject *self, Py_s
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___setslice__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___setslice__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t___setslice__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T___setslice__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< double >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_t___setslice__" "', argument " "3"" of type '" "std::vector< double >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_T___setslice__" "', argument " "3"" of type '" "std::vector< double >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< double >::difference_type >(val3);
   {
     std::vector< double,std::allocator< double > > *ptr = (std::vector< double,std::allocator< double > > *)0;
     res4 = swig::asptr(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vdouble1d_t___setslice__" "', argument " "4"" of type '" "std::vector< double,std::allocator< double > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vdouble1d_T___setslice__" "', argument " "4"" of type '" "std::vector< double,std::allocator< double > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble1d_t___setslice__" "', argument " "4"" of type '" "std::vector< double,std::allocator< double > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble1d_T___setslice__" "', argument " "4"" of type '" "std::vector< double,std::allocator< double > > const &""'"); 
     }
     arg4 = ptr;
   }
@@ -8291,13 +8291,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___setslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___setslice__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_t___setslice__", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_T___setslice__", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -8314,7 +8314,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setslice__(PyObject *self, PyObject *ar
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vdouble1d_t___setslice____SWIG_0(self, argc, argv);
+          return _wrap_vdouble1d_T___setslice____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -8337,7 +8337,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setslice__(PyObject *self, PyObject *ar
           int res = swig::asptr(argv[3], (std::vector< double,std::allocator< double > >**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vdouble1d_t___setslice____SWIG_1(self, argc, argv);
+            return _wrap_vdouble1d_T___setslice____SWIG_1(self, argc, argv);
           }
         }
       }
@@ -8345,7 +8345,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setslice__(PyObject *self, PyObject *ar
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_t___setslice__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_T___setslice__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< double >::__setslice__(std::vector< double >::difference_type,std::vector< double >::difference_type)\n"
     "    std::vector< double >::__setslice__(std::vector< double >::difference_type,std::vector< double >::difference_type,std::vector< double,std::allocator< double > > const &)\n");
@@ -8353,7 +8353,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___delslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___delslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::difference_type arg2 ;
@@ -8367,20 +8367,20 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___delslice__(PyObject *self, PyObject *ar
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_t___delslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_T___delslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___delslice__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___delslice__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t___delslice__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T___delslice__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< double >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_t___delslice__" "', argument " "3"" of type '" "std::vector< double >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_T___delslice__" "', argument " "3"" of type '" "std::vector< double >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< double >::difference_type >(val3);
   try {
@@ -8397,7 +8397,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::difference_type arg2 ;
@@ -8410,12 +8410,12 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___delitem____SWIG_0(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___delitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___delitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t___delitem__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T___delitem__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< double >::difference_type >(val2);
   try {
@@ -8432,7 +8432,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -8444,12 +8444,12 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___getitem____SWIG_0(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___getitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___getitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -8467,7 +8467,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -8480,12 +8480,12 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setitem____SWIG_0(PyObject *self, Py_ss
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___setitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___setitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -8493,10 +8493,10 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setitem____SWIG_0(PyObject *self, Py_ss
     std::vector< double,std::allocator< double > > *ptr = (std::vector< double,std::allocator< double > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble1d_t___setitem__" "', argument " "3"" of type '" "std::vector< double,std::allocator< double > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble1d_T___setitem__" "', argument " "3"" of type '" "std::vector< double,std::allocator< double > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble1d_t___setitem__" "', argument " "3"" of type '" "std::vector< double,std::allocator< double > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble1d_T___setitem__" "', argument " "3"" of type '" "std::vector< double,std::allocator< double > > const &""'"); 
     }
     arg3 = ptr;
   }
@@ -8516,7 +8516,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -8527,12 +8527,12 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setitem____SWIG_1(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___setitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___setitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -8550,7 +8550,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -8561,12 +8561,12 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___delitem____SWIG_1(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___delitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___delitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -8584,13 +8584,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___delitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___delitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_t___delitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_T___delitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -8601,7 +8601,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___delitem__(PyObject *self, PyObject *arg
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vdouble1d_t___delitem____SWIG_1(self, argc, argv);
+        return _wrap_vdouble1d_T___delitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -8615,13 +8615,13 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___delitem__(PyObject *self, PyObject *arg
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vdouble1d_t___delitem____SWIG_0(self, argc, argv);
+        return _wrap_vdouble1d_T___delitem____SWIG_0(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_t___delitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_T___delitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< double >::__delitem__(std::vector< double >::difference_type)\n"
     "    std::vector< double >::__delitem__(SWIGPY_SLICEOBJECT *)\n");
@@ -8629,7 +8629,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::difference_type arg2 ;
@@ -8643,12 +8643,12 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___getitem____SWIG_1(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___getitem__" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___getitem__" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t___getitem__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T___getitem__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< double >::difference_type >(val2);
   try {
@@ -8664,13 +8664,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___getitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___getitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_t___getitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_T___getitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -8681,7 +8681,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___getitem__(PyObject *self, PyObject *arg
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vdouble1d_t___getitem____SWIG_0(self, argc, argv);
+        return _wrap_vdouble1d_T___getitem____SWIG_0(self, argc, argv);
       }
     }
   }
@@ -8695,13 +8695,13 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___getitem__(PyObject *self, PyObject *arg
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vdouble1d_t___getitem____SWIG_1(self, argc, argv);
+        return _wrap_vdouble1d_T___getitem____SWIG_1(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_t___getitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_T___getitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< double >::__getitem__(SWIGPY_SLICEOBJECT *)\n"
     "    std::vector< double >::__getitem__(std::vector< double >::difference_type) const\n");
@@ -8709,7 +8709,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::difference_type arg2 ;
@@ -8726,17 +8726,17 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setitem____SWIG_2(PyObject *self, Py_ss
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___setitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___setitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t___setitem__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T___setitem__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< double >::difference_type >(val2);
   ecode3 = SWIG_AsVal_double(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_t___setitem__" "', argument " "3"" of type '" "std::vector< double >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_T___setitem__" "', argument " "3"" of type '" "std::vector< double >::value_type""'");
   } 
   temp3 = static_cast< std::vector< double >::value_type >(val3);
   arg3 = &temp3;
@@ -8752,13 +8752,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___setitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___setitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_t___setitem__", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_T___setitem__", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -8769,7 +8769,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setitem__(PyObject *self, PyObject *arg
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vdouble1d_t___setitem____SWIG_1(self, argc, argv);
+        return _wrap_vdouble1d_T___setitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -8785,7 +8785,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setitem__(PyObject *self, PyObject *arg
         int res = swig::asptr(argv[2], (std::vector< double,std::allocator< double > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vdouble1d_t___setitem____SWIG_0(self, argc, argv);
+          return _wrap_vdouble1d_T___setitem____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -8805,14 +8805,14 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setitem__(PyObject *self, PyObject *arg
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vdouble1d_t___setitem____SWIG_2(self, argc, argv);
+          return _wrap_vdouble1d_T___setitem____SWIG_2(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_t___setitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_T___setitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< double >::__setitem__(SWIGPY_SLICEOBJECT *,std::vector< double,std::allocator< double > > const &)\n"
     "    std::vector< double >::__setitem__(SWIGPY_SLICEOBJECT *)\n"
@@ -8821,7 +8821,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_pop(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_pop(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -8834,7 +8834,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_pop(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_pop" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_pop" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   try {
@@ -8849,7 +8849,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_append(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_append(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::value_type *arg2 = 0 ;
@@ -8861,15 +8861,15 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_append(PyObject *self, PyObject *args) {
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_t_append", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_T_append", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_append" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_append" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_double(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t_append" "', argument " "2"" of type '" "std::vector< double >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T_append" "', argument " "2"" of type '" "std::vector< double >::value_type""'");
   } 
   temp2 = static_cast< std::vector< double >::value_type >(val2);
   arg2 = &temp2;
@@ -8881,7 +8881,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vdouble1d_t__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
+SWIGINTERN PyObject *_wrap_new_vdouble1d_T__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
   PyObject *resultobj = 0;
   std::vector< double > *result = 0 ;
   
@@ -8895,7 +8895,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vdouble1d_t__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vdouble1d_T__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = 0 ;
   int res1 = SWIG_OLDOBJ ;
@@ -8907,10 +8907,10 @@ SWIGINTERN PyObject *_wrap_new_vdouble1d_t__SWIG_1(PyObject *self, Py_ssize_t no
     std::vector< double,std::allocator< double > > *ptr = (std::vector< double,std::allocator< double > > *)0;
     res1 = swig::asptr(swig_obj[0], &ptr);
     if (!SWIG_IsOK(res1)) {
-      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vdouble1d_t" "', argument " "1"" of type '" "std::vector< double > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vdouble1d_T" "', argument " "1"" of type '" "std::vector< double > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vdouble1d_t" "', argument " "1"" of type '" "std::vector< double > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vdouble1d_T" "', argument " "1"" of type '" "std::vector< double > const &""'"); 
     }
     arg1 = ptr;
   }
@@ -8924,7 +8924,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_empty(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_empty(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -8937,7 +8937,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_empty(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_empty" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_empty" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = (bool)((std::vector< double > const *)arg1)->empty();
@@ -8948,7 +8948,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_size(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_size(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -8961,7 +8961,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_size(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_size" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_size" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = ((std::vector< double > const *)arg1)->size();
@@ -8972,7 +8972,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_swap(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_swap(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double > *arg2 = 0 ;
@@ -8983,18 +8983,18 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_swap(PyObject *self, PyObject *args) {
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_t_swap", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_T_swap", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_swap" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_swap" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], &argp2, SWIGTYPE_p_std__vectorT_double_t,  0 );
   if (!SWIG_IsOK(res2)) {
-    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vdouble1d_t_swap" "', argument " "2"" of type '" "std::vector< double > &""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vdouble1d_T_swap" "', argument " "2"" of type '" "std::vector< double > &""'"); 
   }
   if (!argp2) {
-    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble1d_t_swap" "', argument " "2"" of type '" "std::vector< double > &""'"); 
+    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble1d_T_swap" "', argument " "2"" of type '" "std::vector< double > &""'"); 
   }
   arg2 = reinterpret_cast< std::vector< double > * >(argp2);
   (arg1)->swap(*arg2);
@@ -9005,7 +9005,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_begin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_begin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -9018,7 +9018,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_begin(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_begin" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_begin" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = (arg1)->begin();
@@ -9030,7 +9030,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_end(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_end(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -9043,7 +9043,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_end(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_end" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_end" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = (arg1)->end();
@@ -9055,7 +9055,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_rbegin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_rbegin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -9068,7 +9068,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_rbegin(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_rbegin" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_rbegin" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = (arg1)->rbegin();
@@ -9080,7 +9080,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_rend(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_rend(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -9093,7 +9093,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_rend(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_rend" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_rend" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = (arg1)->rend();
@@ -9105,7 +9105,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_clear(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_clear(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -9117,7 +9117,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_clear(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_clear" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_clear" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   (arg1)->clear();
@@ -9128,7 +9128,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_get_allocator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_get_allocator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -9141,7 +9141,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_get_allocator(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_get_allocator" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_get_allocator" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = ((std::vector< double > const *)arg1)->get_allocator();
@@ -9152,7 +9152,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vdouble1d_t__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vdouble1d_T__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double >::size_type arg1 ;
   size_t val1 ;
@@ -9163,7 +9163,7 @@ SWIGINTERN PyObject *_wrap_new_vdouble1d_t__SWIG_2(PyObject *self, Py_ssize_t no
   if ((nobjs < 1) || (nobjs > 1)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vdouble1d_t" "', argument " "1"" of type '" "std::vector< double >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vdouble1d_T" "', argument " "1"" of type '" "std::vector< double >::size_type""'");
   } 
   arg1 = static_cast< std::vector< double >::size_type >(val1);
   result = (std::vector< double > *)new std::vector< double >(arg1);
@@ -9174,7 +9174,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_pop_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_pop_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -9186,7 +9186,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_pop_back(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_pop_back" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_pop_back" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   (arg1)->pop_back();
@@ -9197,7 +9197,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::size_type arg2 ;
@@ -9210,12 +9210,12 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_resize__SWIG_0(PyObject *self, Py_ssize_t
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_resize" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_resize" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t_resize" "', argument " "2"" of type '" "std::vector< double >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T_resize" "', argument " "2"" of type '" "std::vector< double >::size_type""'");
   } 
   arg2 = static_cast< std::vector< double >::size_type >(val2);
   (arg1)->resize(arg2);
@@ -9226,7 +9226,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::iterator arg2 ;
@@ -9240,18 +9240,18 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_erase__SWIG_0(PyObject *self, Py_ssize_t
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_erase" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_erase" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t_erase" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T_erase" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< double >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< double >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t_erase" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T_erase" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
     }
   }
   result = std_vector_Sl_double_Sg__erase__SWIG_0(arg1,SWIG_STD_MOVE(arg2));
@@ -9263,7 +9263,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::iterator arg2 ;
@@ -9280,29 +9280,29 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_erase__SWIG_1(PyObject *self, Py_ssize_t
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_erase" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_erase" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t_erase" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T_erase" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< double >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< double >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t_erase" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T_erase" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
     }
   }
   res3 = SWIG_ConvertPtr(swig_obj[2], SWIG_as_voidptrptr(&iter3), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res3) || !iter3) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t_erase" "', argument " "3"" of type '" "std::vector< double >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T_erase" "', argument " "3"" of type '" "std::vector< double >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< double >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< double >::iterator > *>(iter3);
     if (iter_t) {
       arg3 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t_erase" "', argument " "3"" of type '" "std::vector< double >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T_erase" "', argument " "3"" of type '" "std::vector< double >::iterator""'");
     }
   }
   result = std_vector_Sl_double_Sg__erase__SWIG_1(arg1,SWIG_STD_MOVE(arg2),SWIG_STD_MOVE(arg3));
@@ -9314,13 +9314,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_erase(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_erase(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_t_erase", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_T_erase", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -9331,7 +9331,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_erase(PyObject *self, PyObject *args) {
       int res = SWIG_ConvertPtr(argv[1], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
       _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< double >::iterator > *>(iter) != 0));
       if (_v) {
-        return _wrap_vdouble1d_t_erase__SWIG_0(self, argc, argv);
+        return _wrap_vdouble1d_T_erase__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -9348,14 +9348,14 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_erase(PyObject *self, PyObject *args) {
         int res = SWIG_ConvertPtr(argv[2], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
         _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< double >::iterator > *>(iter) != 0));
         if (_v) {
-          return _wrap_vdouble1d_t_erase__SWIG_1(self, argc, argv);
+          return _wrap_vdouble1d_T_erase__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_t_erase'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_T_erase'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< double >::erase(std::vector< double >::iterator)\n"
     "    std::vector< double >::erase(std::vector< double >::iterator,std::vector< double >::iterator)\n");
@@ -9363,7 +9363,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vdouble1d_t__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vdouble1d_T__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double >::size_type arg1 ;
   std::vector< double >::value_type *arg2 = 0 ;
@@ -9378,12 +9378,12 @@ SWIGINTERN PyObject *_wrap_new_vdouble1d_t__SWIG_3(PyObject *self, Py_ssize_t no
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vdouble1d_t" "', argument " "1"" of type '" "std::vector< double >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vdouble1d_T" "', argument " "1"" of type '" "std::vector< double >::size_type""'");
   } 
   arg1 = static_cast< std::vector< double >::size_type >(val1);
   ecode2 = SWIG_AsVal_double(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "new_vdouble1d_t" "', argument " "2"" of type '" "std::vector< double >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "new_vdouble1d_T" "', argument " "2"" of type '" "std::vector< double >::value_type""'");
   } 
   temp2 = static_cast< std::vector< double >::value_type >(val2);
   arg2 = &temp2;
@@ -9395,16 +9395,16 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vdouble1d_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_new_vdouble1d_T(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vdouble1d_t", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vdouble1d_T", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 0) {
-    return _wrap_new_vdouble1d_t__SWIG_0(self, argc, argv);
+    return _wrap_new_vdouble1d_T__SWIG_0(self, argc, argv);
   }
   if (argc == 1) {
     int _v = 0;
@@ -9413,7 +9413,7 @@ SWIGINTERN PyObject *_wrap_new_vdouble1d_t(PyObject *self, PyObject *args) {
       _v = SWIG_CheckState(res);
     }
     if (_v) {
-      return _wrap_new_vdouble1d_t__SWIG_2(self, argc, argv);
+      return _wrap_new_vdouble1d_T__SWIG_2(self, argc, argv);
     }
   }
   if (argc == 1) {
@@ -9421,7 +9421,7 @@ SWIGINTERN PyObject *_wrap_new_vdouble1d_t(PyObject *self, PyObject *args) {
     int res = swig::asptr(argv[0], (std::vector< double,std::allocator< double > >**)(0));
     _v = SWIG_CheckState(res);
     if (_v) {
-      return _wrap_new_vdouble1d_t__SWIG_1(self, argc, argv);
+      return _wrap_new_vdouble1d_T__SWIG_1(self, argc, argv);
     }
   }
   if (argc == 2) {
@@ -9436,13 +9436,13 @@ SWIGINTERN PyObject *_wrap_new_vdouble1d_t(PyObject *self, PyObject *args) {
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_new_vdouble1d_t__SWIG_3(self, argc, argv);
+        return _wrap_new_vdouble1d_T__SWIG_3(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vdouble1d_t'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vdouble1d_T'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< double >::vector()\n"
     "    std::vector< double >::vector(std::vector< double > const &)\n"
@@ -9452,7 +9452,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_push_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_push_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::value_type *arg2 = 0 ;
@@ -9464,15 +9464,15 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_push_back(PyObject *self, PyObject *args)
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_t_push_back", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_T_push_back", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_push_back" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_push_back" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_double(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t_push_back" "', argument " "2"" of type '" "std::vector< double >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T_push_back" "', argument " "2"" of type '" "std::vector< double >::value_type""'");
   } 
   temp2 = static_cast< std::vector< double >::value_type >(val2);
   arg2 = &temp2;
@@ -9484,7 +9484,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_front(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_front(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -9497,7 +9497,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_front(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_front" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_front" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = (std::vector< double >::value_type *) &((std::vector< double > const *)arg1)->front();
@@ -9509,7 +9509,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -9522,7 +9522,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_back(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_back" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_back" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = (std::vector< double >::value_type *) &((std::vector< double > const *)arg1)->back();
@@ -9534,7 +9534,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_assign(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_assign(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::size_type arg2 ;
@@ -9549,20 +9549,20 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_assign(PyObject *self, PyObject *args) {
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_t_assign", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_T_assign", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_assign" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_assign" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t_assign" "', argument " "2"" of type '" "std::vector< double >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T_assign" "', argument " "2"" of type '" "std::vector< double >::size_type""'");
   } 
   arg2 = static_cast< std::vector< double >::size_type >(val2);
   ecode3 = SWIG_AsVal_double(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_t_assign" "', argument " "3"" of type '" "std::vector< double >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_T_assign" "', argument " "3"" of type '" "std::vector< double >::value_type""'");
   } 
   temp3 = static_cast< std::vector< double >::value_type >(val3);
   arg3 = &temp3;
@@ -9574,7 +9574,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::size_type arg2 ;
@@ -9591,17 +9591,17 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_resize__SWIG_1(PyObject *self, Py_ssize_t
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_resize" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_resize" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t_resize" "', argument " "2"" of type '" "std::vector< double >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T_resize" "', argument " "2"" of type '" "std::vector< double >::size_type""'");
   } 
   arg2 = static_cast< std::vector< double >::size_type >(val2);
   ecode3 = SWIG_AsVal_double(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_t_resize" "', argument " "3"" of type '" "std::vector< double >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_T_resize" "', argument " "3"" of type '" "std::vector< double >::value_type""'");
   } 
   temp3 = static_cast< std::vector< double >::value_type >(val3);
   arg3 = &temp3;
@@ -9613,13 +9613,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_resize(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_resize(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_t_resize", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_T_resize", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -9631,7 +9631,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_resize(PyObject *self, PyObject *args) {
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vdouble1d_t_resize__SWIG_0(self, argc, argv);
+        return _wrap_vdouble1d_T_resize__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -9650,14 +9650,14 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_resize(PyObject *self, PyObject *args) {
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vdouble1d_t_resize__SWIG_1(self, argc, argv);
+          return _wrap_vdouble1d_T_resize__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_t_resize'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_T_resize'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< double >::resize(std::vector< double >::size_type)\n"
     "    std::vector< double >::resize(std::vector< double >::size_type,std::vector< double >::value_type const &)\n");
@@ -9665,7 +9665,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::iterator arg2 ;
@@ -9683,23 +9683,23 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_insert__SWIG_0(PyObject *self, Py_ssize_t
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_insert" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_insert" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t_insert" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T_insert" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< double >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< double >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t_insert" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T_insert" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_double(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_t_insert" "', argument " "3"" of type '" "std::vector< double >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_T_insert" "', argument " "3"" of type '" "std::vector< double >::value_type""'");
   } 
   temp3 = static_cast< std::vector< double >::value_type >(val3);
   arg3 = &temp3;
@@ -9712,7 +9712,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::iterator arg2 ;
@@ -9732,28 +9732,28 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_insert__SWIG_1(PyObject *self, Py_ssize_t
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_insert" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_insert" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t_insert" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T_insert" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< double >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< double >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t_insert" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T_insert" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_size_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_t_insert" "', argument " "3"" of type '" "std::vector< double >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_T_insert" "', argument " "3"" of type '" "std::vector< double >::size_type""'");
   } 
   arg3 = static_cast< std::vector< double >::size_type >(val3);
   ecode4 = SWIG_AsVal_double(swig_obj[3], &val4);
   if (!SWIG_IsOK(ecode4)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode4), "in method '" "vdouble1d_t_insert" "', argument " "4"" of type '" "std::vector< double >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode4), "in method '" "vdouble1d_T_insert" "', argument " "4"" of type '" "std::vector< double >::value_type""'");
   } 
   temp4 = static_cast< std::vector< double >::value_type >(val4);
   arg4 = &temp4;
@@ -9765,13 +9765,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_insert(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_insert(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_t_insert", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_T_insert", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -9787,7 +9787,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_insert(PyObject *self, PyObject *args) {
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vdouble1d_t_insert__SWIG_0(self, argc, argv);
+          return _wrap_vdouble1d_T_insert__SWIG_0(self, argc, argv);
         }
       }
     }
@@ -9811,7 +9811,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_insert(PyObject *self, PyObject *args) {
             _v = SWIG_CheckState(res);
           }
           if (_v) {
-            return _wrap_vdouble1d_t_insert__SWIG_1(self, argc, argv);
+            return _wrap_vdouble1d_T_insert__SWIG_1(self, argc, argv);
           }
         }
       }
@@ -9819,7 +9819,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_insert(PyObject *self, PyObject *args) {
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_t_insert'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_T_insert'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< double >::insert(std::vector< double >::iterator,std::vector< double >::value_type const &)\n"
     "    std::vector< double >::insert(std::vector< double >::iterator,std::vector< double >::size_type,std::vector< double >::value_type const &)\n");
@@ -9827,7 +9827,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_reserve(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_reserve(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::size_type arg2 ;
@@ -9838,15 +9838,15 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_reserve(PyObject *self, PyObject *args) {
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_t_reserve", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_T_reserve", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_reserve" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_reserve" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t_reserve" "', argument " "2"" of type '" "std::vector< double >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T_reserve" "', argument " "2"" of type '" "std::vector< double >::size_type""'");
   } 
   arg2 = static_cast< std::vector< double >::size_type >(val2);
   (arg1)->reserve(arg2);
@@ -9857,7 +9857,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_capacity(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_capacity(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -9870,7 +9870,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_capacity(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_capacity" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_capacity" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = ((std::vector< double > const *)arg1)->capacity();
@@ -9881,7 +9881,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_delete_vdouble1d_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_delete_vdouble1d_T(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -9893,7 +9893,7 @@ SWIGINTERN PyObject *_wrap_delete_vdouble1d_t(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, SWIG_POINTER_DISOWN |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vdouble1d_t" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vdouble1d_T" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   {
@@ -9914,18 +9914,18 @@ fail:
 }
 
 
-SWIGINTERN PyObject *vdouble1d_t_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vdouble1d_T_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   PyObject *obj;
   if (!SWIG_Python_UnpackTuple(args, "swigregister", 1, 1, &obj)) return NULL;
   SWIG_TypeNewClientData(SWIGTYPE_p_std__vectorT_double_t, SWIG_NewClientData(obj));
   return SWIG_Py_Void();
 }
 
-SWIGINTERN PyObject *vdouble1d_t_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vdouble1d_T_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   return SWIG_Python_InitShadowInstance(args);
 }
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_iterator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_iterator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   PyObject **arg2 = (PyObject **) 0 ;
@@ -9940,7 +9940,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_iterator(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_iterator" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_iterator" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = (swig::SwigPyIterator *)std_vector_Sl_std_vector_Sl_double_Sg__Sg__iterator(arg1,arg2);
@@ -9951,7 +9951,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___nonzero__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___nonzero__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -9964,7 +9964,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___nonzero__(PyObject *self, PyObject *arg
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___nonzero__" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___nonzero__" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = (bool)std_vector_Sl_std_vector_Sl_double_Sg__Sg____nonzero__((std::vector< std::vector< double > > const *)arg1);
@@ -9975,7 +9975,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___bool__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___bool__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -9988,7 +9988,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___bool__(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___bool__" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___bool__" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = (bool)std_vector_Sl_std_vector_Sl_double_Sg__Sg____bool__((std::vector< std::vector< double > > const *)arg1);
@@ -9999,7 +9999,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___len__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___len__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -10012,7 +10012,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___len__(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___len__" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___len__" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = std_vector_Sl_std_vector_Sl_double_Sg__Sg____len__((std::vector< std::vector< double > > const *)arg1);
@@ -10023,7 +10023,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___getslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___getslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::difference_type arg2 ;
@@ -10038,20 +10038,20 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___getslice__(PyObject *self, PyObject *ar
   std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > *result = 0 ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_t___getslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_T___getslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___getslice__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___getslice__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_t___getslice__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_T___getslice__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble2d_t___getslice__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble2d_T___getslice__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::vector< double > >::difference_type >(val3);
   try {
@@ -10068,7 +10068,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::difference_type arg2 ;
@@ -10084,17 +10084,17 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setslice____SWIG_0(PyObject *self, Py_s
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___setslice__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___setslice__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_t___setslice__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_T___setslice__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble2d_t___setslice__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble2d_T___setslice__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::vector< double > >::difference_type >(val3);
   try {
@@ -10111,7 +10111,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::difference_type arg2 ;
@@ -10129,27 +10129,27 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setslice____SWIG_1(PyObject *self, Py_s
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___setslice__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___setslice__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_t___setslice__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_T___setslice__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble2d_t___setslice__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble2d_T___setslice__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::vector< double > >::difference_type >(val3);
   {
     std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > *ptr = (std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > *)0;
     res4 = swig::asptr(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vdouble2d_t___setslice__" "', argument " "4"" of type '" "std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vdouble2d_T___setslice__" "', argument " "4"" of type '" "std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_t___setslice__" "', argument " "4"" of type '" "std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_T___setslice__" "', argument " "4"" of type '" "std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > const &""'"); 
     }
     arg4 = ptr;
   }
@@ -10169,13 +10169,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___setslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___setslice__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_t___setslice__", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_T___setslice__", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -10192,7 +10192,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setslice__(PyObject *self, PyObject *ar
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vdouble2d_t___setslice____SWIG_0(self, argc, argv);
+          return _wrap_vdouble2d_T___setslice____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -10215,7 +10215,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setslice__(PyObject *self, PyObject *ar
           int res = swig::asptr(argv[3], (std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > >**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vdouble2d_t___setslice____SWIG_1(self, argc, argv);
+            return _wrap_vdouble2d_T___setslice____SWIG_1(self, argc, argv);
           }
         }
       }
@@ -10223,7 +10223,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setslice__(PyObject *self, PyObject *ar
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_t___setslice__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_T___setslice__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< double > >::__setslice__(std::vector< std::vector< double > >::difference_type,std::vector< std::vector< double > >::difference_type)\n"
     "    std::vector< std::vector< double > >::__setslice__(std::vector< std::vector< double > >::difference_type,std::vector< std::vector< double > >::difference_type,std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > const &)\n");
@@ -10231,7 +10231,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___delslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___delslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::difference_type arg2 ;
@@ -10245,20 +10245,20 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___delslice__(PyObject *self, PyObject *ar
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_t___delslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_T___delslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___delslice__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___delslice__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_t___delslice__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_T___delslice__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble2d_t___delslice__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble2d_T___delslice__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::vector< double > >::difference_type >(val3);
   try {
@@ -10275,7 +10275,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::difference_type arg2 ;
@@ -10288,12 +10288,12 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___delitem____SWIG_0(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___delitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___delitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_t___delitem__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_T___delitem__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< double > >::difference_type >(val2);
   try {
@@ -10310,7 +10310,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -10322,12 +10322,12 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___getitem____SWIG_0(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___getitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___getitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -10345,7 +10345,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -10358,12 +10358,12 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setitem____SWIG_0(PyObject *self, Py_ss
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -10371,10 +10371,10 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setitem____SWIG_0(PyObject *self, Py_ss
     std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > *ptr = (std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble2d_t___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble2d_T___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_t___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_T___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > const &""'"); 
     }
     arg3 = ptr;
   }
@@ -10394,7 +10394,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -10405,12 +10405,12 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setitem____SWIG_1(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -10428,7 +10428,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -10439,12 +10439,12 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___delitem____SWIG_1(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___delitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___delitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -10462,13 +10462,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___delitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___delitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_t___delitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_T___delitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -10479,7 +10479,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___delitem__(PyObject *self, PyObject *arg
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vdouble2d_t___delitem____SWIG_1(self, argc, argv);
+        return _wrap_vdouble2d_T___delitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -10493,13 +10493,13 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___delitem__(PyObject *self, PyObject *arg
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vdouble2d_t___delitem____SWIG_0(self, argc, argv);
+        return _wrap_vdouble2d_T___delitem____SWIG_0(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_t___delitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_T___delitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< double > >::__delitem__(std::vector< std::vector< double > >::difference_type)\n"
     "    std::vector< std::vector< double > >::__delitem__(SWIGPY_SLICEOBJECT *)\n");
@@ -10507,7 +10507,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::difference_type arg2 ;
@@ -10521,12 +10521,12 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___getitem____SWIG_1(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___getitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___getitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_t___getitem__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_T___getitem__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< double > >::difference_type >(val2);
   try {
@@ -10542,13 +10542,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___getitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___getitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_t___getitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_T___getitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -10559,7 +10559,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___getitem__(PyObject *self, PyObject *arg
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vdouble2d_t___getitem____SWIG_0(self, argc, argv);
+        return _wrap_vdouble2d_T___getitem____SWIG_0(self, argc, argv);
       }
     }
   }
@@ -10573,13 +10573,13 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___getitem__(PyObject *self, PyObject *arg
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vdouble2d_t___getitem____SWIG_1(self, argc, argv);
+        return _wrap_vdouble2d_T___getitem____SWIG_1(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_t___getitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_T___getitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< double > >::__getitem__(SWIGPY_SLICEOBJECT *)\n"
     "    std::vector< std::vector< double > >::__getitem__(std::vector< std::vector< double > >::difference_type) const\n");
@@ -10587,7 +10587,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::difference_type arg2 ;
@@ -10602,22 +10602,22 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setitem____SWIG_2(PyObject *self, Py_ss
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_t___setitem__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_T___setitem__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< double > >::difference_type >(val2);
   {
     std::vector< double,std::allocator< double > > *ptr = (std::vector< double,std::allocator< double > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble2d_t___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble2d_T___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_t___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_T___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -10635,13 +10635,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___setitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___setitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_t___setitem__", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_T___setitem__", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -10652,7 +10652,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setitem__(PyObject *self, PyObject *arg
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vdouble2d_t___setitem____SWIG_1(self, argc, argv);
+        return _wrap_vdouble2d_T___setitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -10668,7 +10668,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setitem__(PyObject *self, PyObject *arg
         int res = swig::asptr(argv[2], (std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vdouble2d_t___setitem____SWIG_0(self, argc, argv);
+          return _wrap_vdouble2d_T___setitem____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -10686,14 +10686,14 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setitem__(PyObject *self, PyObject *arg
         int res = swig::asptr(argv[2], (std::vector< double,std::allocator< double > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vdouble2d_t___setitem____SWIG_2(self, argc, argv);
+          return _wrap_vdouble2d_T___setitem____SWIG_2(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_t___setitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_T___setitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< double > >::__setitem__(SWIGPY_SLICEOBJECT *,std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > const &)\n"
     "    std::vector< std::vector< double > >::__setitem__(SWIGPY_SLICEOBJECT *)\n"
@@ -10702,7 +10702,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_pop(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_pop(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -10715,7 +10715,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_pop(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_pop" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_pop" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   try {
@@ -10730,7 +10730,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_append(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_append(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::value_type *arg2 = 0 ;
@@ -10740,20 +10740,20 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_append(PyObject *self, PyObject *args) {
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_t_append", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_T_append", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_append" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_append" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   {
     std::vector< double,std::allocator< double > > *ptr = (std::vector< double,std::allocator< double > > *)0;
     res2 = swig::asptr(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vdouble2d_t_append" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vdouble2d_T_append" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_t_append" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_T_append" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -10767,7 +10767,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vdouble2d_t__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
+SWIGINTERN PyObject *_wrap_new_vdouble2d_T__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *result = 0 ;
   
@@ -10781,7 +10781,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vdouble2d_t__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vdouble2d_T__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double,std::allocator< double > > > *arg1 = 0 ;
   int res1 = SWIG_OLDOBJ ;
@@ -10793,10 +10793,10 @@ SWIGINTERN PyObject *_wrap_new_vdouble2d_t__SWIG_1(PyObject *self, Py_ssize_t no
     std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > *ptr = (std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > *)0;
     res1 = swig::asptr(swig_obj[0], &ptr);
     if (!SWIG_IsOK(res1)) {
-      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vdouble2d_t" "', argument " "1"" of type '" "std::vector< std::vector< double,std::allocator< double > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vdouble2d_T" "', argument " "1"" of type '" "std::vector< std::vector< double,std::allocator< double > > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vdouble2d_t" "', argument " "1"" of type '" "std::vector< std::vector< double,std::allocator< double > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vdouble2d_T" "', argument " "1"" of type '" "std::vector< std::vector< double,std::allocator< double > > > const &""'"); 
     }
     arg1 = ptr;
   }
@@ -10810,7 +10810,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_empty(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_empty(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -10823,7 +10823,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_empty(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_empty" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_empty" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = (bool)((std::vector< std::vector< double > > const *)arg1)->empty();
@@ -10834,7 +10834,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_size(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_size(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -10847,7 +10847,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_size(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_size" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_size" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = ((std::vector< std::vector< double > > const *)arg1)->size();
@@ -10858,7 +10858,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_swap(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_swap(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double,std::allocator< double > > > *arg2 = 0 ;
@@ -10869,18 +10869,18 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_swap(PyObject *self, PyObject *args) {
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_t_swap", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_T_swap", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_swap" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_swap" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], &argp2, SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t,  0 );
   if (!SWIG_IsOK(res2)) {
-    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vdouble2d_t_swap" "', argument " "2"" of type '" "std::vector< std::vector< double,std::allocator< double > > > &""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vdouble2d_T_swap" "', argument " "2"" of type '" "std::vector< std::vector< double,std::allocator< double > > > &""'"); 
   }
   if (!argp2) {
-    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_t_swap" "', argument " "2"" of type '" "std::vector< std::vector< double,std::allocator< double > > > &""'"); 
+    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_T_swap" "', argument " "2"" of type '" "std::vector< std::vector< double,std::allocator< double > > > &""'"); 
   }
   arg2 = reinterpret_cast< std::vector< std::vector< double,std::allocator< double > > > * >(argp2);
   (arg1)->swap(*arg2);
@@ -10891,7 +10891,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_begin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_begin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -10904,7 +10904,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_begin(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_begin" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_begin" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = (arg1)->begin();
@@ -10916,7 +10916,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_end(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_end(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -10929,7 +10929,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_end(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_end" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_end" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = (arg1)->end();
@@ -10941,7 +10941,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_rbegin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_rbegin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -10954,7 +10954,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_rbegin(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_rbegin" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_rbegin" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = (arg1)->rbegin();
@@ -10966,7 +10966,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_rend(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_rend(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -10979,7 +10979,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_rend(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_rend" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_rend" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = (arg1)->rend();
@@ -10991,7 +10991,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_clear(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_clear(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -11003,7 +11003,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_clear(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_clear" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_clear" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   (arg1)->clear();
@@ -11014,7 +11014,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_get_allocator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_get_allocator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -11027,7 +11027,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_get_allocator(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_get_allocator" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_get_allocator" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = ((std::vector< std::vector< double > > const *)arg1)->get_allocator();
@@ -11038,7 +11038,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vdouble2d_t__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vdouble2d_T__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > >::size_type arg1 ;
   size_t val1 ;
@@ -11049,7 +11049,7 @@ SWIGINTERN PyObject *_wrap_new_vdouble2d_t__SWIG_2(PyObject *self, Py_ssize_t no
   if ((nobjs < 1) || (nobjs > 1)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vdouble2d_t" "', argument " "1"" of type '" "std::vector< std::vector< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vdouble2d_T" "', argument " "1"" of type '" "std::vector< std::vector< double > >::size_type""'");
   } 
   arg1 = static_cast< std::vector< std::vector< double > >::size_type >(val1);
   result = (std::vector< std::vector< double > > *)new std::vector< std::vector< double > >(arg1);
@@ -11060,7 +11060,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_pop_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_pop_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -11072,7 +11072,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_pop_back(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_pop_back" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_pop_back" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   (arg1)->pop_back();
@@ -11083,7 +11083,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::size_type arg2 ;
@@ -11096,12 +11096,12 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_resize__SWIG_0(PyObject *self, Py_ssize_t
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_resize" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_resize" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_t_resize" "', argument " "2"" of type '" "std::vector< std::vector< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_T_resize" "', argument " "2"" of type '" "std::vector< std::vector< double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< double > >::size_type >(val2);
   (arg1)->resize(arg2);
@@ -11112,7 +11112,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::iterator arg2 ;
@@ -11126,18 +11126,18 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_erase__SWIG_0(PyObject *self, Py_ssize_t
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_erase" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_erase" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t_erase" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T_erase" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t_erase" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T_erase" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
     }
   }
   result = std_vector_Sl_std_vector_Sl_double_Sg__Sg__erase__SWIG_0(arg1,SWIG_STD_MOVE(arg2));
@@ -11149,7 +11149,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::iterator arg2 ;
@@ -11166,29 +11166,29 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_erase__SWIG_1(PyObject *self, Py_ssize_t
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_erase" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_erase" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t_erase" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T_erase" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t_erase" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T_erase" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
     }
   }
   res3 = SWIG_ConvertPtr(swig_obj[2], SWIG_as_voidptrptr(&iter3), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res3) || !iter3) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t_erase" "', argument " "3"" of type '" "std::vector< std::vector< double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T_erase" "', argument " "3"" of type '" "std::vector< std::vector< double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *>(iter3);
     if (iter_t) {
       arg3 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t_erase" "', argument " "3"" of type '" "std::vector< std::vector< double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T_erase" "', argument " "3"" of type '" "std::vector< std::vector< double > >::iterator""'");
     }
   }
   result = std_vector_Sl_std_vector_Sl_double_Sg__Sg__erase__SWIG_1(arg1,SWIG_STD_MOVE(arg2),SWIG_STD_MOVE(arg3));
@@ -11200,13 +11200,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_erase(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_erase(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_t_erase", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_T_erase", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -11217,7 +11217,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_erase(PyObject *self, PyObject *args) {
       int res = SWIG_ConvertPtr(argv[1], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
       _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *>(iter) != 0));
       if (_v) {
-        return _wrap_vdouble2d_t_erase__SWIG_0(self, argc, argv);
+        return _wrap_vdouble2d_T_erase__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -11234,14 +11234,14 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_erase(PyObject *self, PyObject *args) {
         int res = SWIG_ConvertPtr(argv[2], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
         _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *>(iter) != 0));
         if (_v) {
-          return _wrap_vdouble2d_t_erase__SWIG_1(self, argc, argv);
+          return _wrap_vdouble2d_T_erase__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_t_erase'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_T_erase'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< double > >::erase(std::vector< std::vector< double > >::iterator)\n"
     "    std::vector< std::vector< double > >::erase(std::vector< std::vector< double > >::iterator,std::vector< std::vector< double > >::iterator)\n");
@@ -11249,7 +11249,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vdouble2d_t__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vdouble2d_T__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > >::size_type arg1 ;
   std::vector< std::vector< double > >::value_type *arg2 = 0 ;
@@ -11262,17 +11262,17 @@ SWIGINTERN PyObject *_wrap_new_vdouble2d_t__SWIG_3(PyObject *self, Py_ssize_t no
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vdouble2d_t" "', argument " "1"" of type '" "std::vector< std::vector< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vdouble2d_T" "', argument " "1"" of type '" "std::vector< std::vector< double > >::size_type""'");
   } 
   arg1 = static_cast< std::vector< std::vector< double > >::size_type >(val1);
   {
     std::vector< double,std::allocator< double > > *ptr = (std::vector< double,std::allocator< double > > *)0;
     res2 = swig::asptr(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "new_vdouble2d_t" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "new_vdouble2d_T" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vdouble2d_t" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vdouble2d_T" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -11286,16 +11286,16 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vdouble2d_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_new_vdouble2d_T(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vdouble2d_t", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vdouble2d_T", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 0) {
-    return _wrap_new_vdouble2d_t__SWIG_0(self, argc, argv);
+    return _wrap_new_vdouble2d_T__SWIG_0(self, argc, argv);
   }
   if (argc == 1) {
     int _v = 0;
@@ -11304,7 +11304,7 @@ SWIGINTERN PyObject *_wrap_new_vdouble2d_t(PyObject *self, PyObject *args) {
       _v = SWIG_CheckState(res);
     }
     if (_v) {
-      return _wrap_new_vdouble2d_t__SWIG_2(self, argc, argv);
+      return _wrap_new_vdouble2d_T__SWIG_2(self, argc, argv);
     }
   }
   if (argc == 1) {
@@ -11312,7 +11312,7 @@ SWIGINTERN PyObject *_wrap_new_vdouble2d_t(PyObject *self, PyObject *args) {
     int res = swig::asptr(argv[0], (std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > >**)(0));
     _v = SWIG_CheckState(res);
     if (_v) {
-      return _wrap_new_vdouble2d_t__SWIG_1(self, argc, argv);
+      return _wrap_new_vdouble2d_T__SWIG_1(self, argc, argv);
     }
   }
   if (argc == 2) {
@@ -11325,13 +11325,13 @@ SWIGINTERN PyObject *_wrap_new_vdouble2d_t(PyObject *self, PyObject *args) {
       int res = swig::asptr(argv[1], (std::vector< double,std::allocator< double > >**)(0));
       _v = SWIG_CheckState(res);
       if (_v) {
-        return _wrap_new_vdouble2d_t__SWIG_3(self, argc, argv);
+        return _wrap_new_vdouble2d_T__SWIG_3(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vdouble2d_t'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vdouble2d_T'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< double > >::vector()\n"
     "    std::vector< std::vector< double > >::vector(std::vector< std::vector< double,std::allocator< double > > > const &)\n"
@@ -11341,7 +11341,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_push_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_push_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::value_type *arg2 = 0 ;
@@ -11351,20 +11351,20 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_push_back(PyObject *self, PyObject *args)
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_t_push_back", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_T_push_back", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_push_back" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_push_back" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   {
     std::vector< double,std::allocator< double > > *ptr = (std::vector< double,std::allocator< double > > *)0;
     res2 = swig::asptr(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vdouble2d_t_push_back" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vdouble2d_T_push_back" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_t_push_back" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_T_push_back" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -11378,7 +11378,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_front(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_front(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -11391,7 +11391,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_front(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_front" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_front" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = (std::vector< std::vector< double > >::value_type *) &((std::vector< std::vector< double > > const *)arg1)->front();
@@ -11403,7 +11403,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -11416,7 +11416,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_back(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_back" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_back" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = (std::vector< std::vector< double > >::value_type *) &((std::vector< std::vector< double > > const *)arg1)->back();
@@ -11428,7 +11428,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_assign(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_assign(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::size_type arg2 ;
@@ -11441,25 +11441,25 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_assign(PyObject *self, PyObject *args) {
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_t_assign", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_T_assign", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_assign" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_assign" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_t_assign" "', argument " "2"" of type '" "std::vector< std::vector< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_T_assign" "', argument " "2"" of type '" "std::vector< std::vector< double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< double > >::size_type >(val2);
   {
     std::vector< double,std::allocator< double > > *ptr = (std::vector< double,std::allocator< double > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble2d_t_assign" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble2d_T_assign" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_t_assign" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_T_assign" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -11473,7 +11473,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::size_type arg2 ;
@@ -11488,22 +11488,22 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_resize__SWIG_1(PyObject *self, Py_ssize_t
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_resize" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_resize" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_t_resize" "', argument " "2"" of type '" "std::vector< std::vector< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_T_resize" "', argument " "2"" of type '" "std::vector< std::vector< double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< double > >::size_type >(val2);
   {
     std::vector< double,std::allocator< double > > *ptr = (std::vector< double,std::allocator< double > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble2d_t_resize" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble2d_T_resize" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_t_resize" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_T_resize" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -11517,13 +11517,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_resize(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_resize(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_t_resize", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_T_resize", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -11535,7 +11535,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_resize(PyObject *self, PyObject *args) {
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vdouble2d_t_resize__SWIG_0(self, argc, argv);
+        return _wrap_vdouble2d_T_resize__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -11552,14 +11552,14 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_resize(PyObject *self, PyObject *args) {
         int res = swig::asptr(argv[2], (std::vector< double,std::allocator< double > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vdouble2d_t_resize__SWIG_1(self, argc, argv);
+          return _wrap_vdouble2d_T_resize__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_t_resize'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_T_resize'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< double > >::resize(std::vector< std::vector< double > >::size_type)\n"
     "    std::vector< std::vector< double > >::resize(std::vector< std::vector< double > >::size_type,std::vector< std::vector< double > >::value_type const &)\n");
@@ -11567,7 +11567,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::iterator arg2 ;
@@ -11583,28 +11583,28 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_insert__SWIG_0(PyObject *self, Py_ssize_t
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_insert" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_insert" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t_insert" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T_insert" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t_insert" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T_insert" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
     }
   }
   {
     std::vector< double,std::allocator< double > > *ptr = (std::vector< double,std::allocator< double > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble2d_t_insert" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble2d_T_insert" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_t_insert" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_T_insert" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -11619,7 +11619,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::iterator arg2 ;
@@ -11637,33 +11637,33 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_insert__SWIG_1(PyObject *self, Py_ssize_t
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_insert" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_insert" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t_insert" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T_insert" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t_insert" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T_insert" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_size_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble2d_t_insert" "', argument " "3"" of type '" "std::vector< std::vector< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble2d_T_insert" "', argument " "3"" of type '" "std::vector< std::vector< double > >::size_type""'");
   } 
   arg3 = static_cast< std::vector< std::vector< double > >::size_type >(val3);
   {
     std::vector< double,std::allocator< double > > *ptr = (std::vector< double,std::allocator< double > > *)0;
     res4 = swig::asptr(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vdouble2d_t_insert" "', argument " "4"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vdouble2d_T_insert" "', argument " "4"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_t_insert" "', argument " "4"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_T_insert" "', argument " "4"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     arg4 = ptr;
   }
@@ -11677,13 +11677,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_insert(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_insert(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_t_insert", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_T_insert", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -11697,7 +11697,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_insert(PyObject *self, PyObject *args) {
         int res = swig::asptr(argv[2], (std::vector< double,std::allocator< double > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vdouble2d_t_insert__SWIG_0(self, argc, argv);
+          return _wrap_vdouble2d_T_insert__SWIG_0(self, argc, argv);
         }
       }
     }
@@ -11719,7 +11719,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_insert(PyObject *self, PyObject *args) {
           int res = swig::asptr(argv[3], (std::vector< double,std::allocator< double > >**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vdouble2d_t_insert__SWIG_1(self, argc, argv);
+            return _wrap_vdouble2d_T_insert__SWIG_1(self, argc, argv);
           }
         }
       }
@@ -11727,7 +11727,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_insert(PyObject *self, PyObject *args) {
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_t_insert'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_T_insert'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< double > >::insert(std::vector< std::vector< double > >::iterator,std::vector< std::vector< double > >::value_type const &)\n"
     "    std::vector< std::vector< double > >::insert(std::vector< std::vector< double > >::iterator,std::vector< std::vector< double > >::size_type,std::vector< std::vector< double > >::value_type const &)\n");
@@ -11735,7 +11735,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_reserve(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_reserve(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::size_type arg2 ;
@@ -11746,15 +11746,15 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_reserve(PyObject *self, PyObject *args) {
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_t_reserve", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_T_reserve", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_reserve" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_reserve" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_t_reserve" "', argument " "2"" of type '" "std::vector< std::vector< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_T_reserve" "', argument " "2"" of type '" "std::vector< std::vector< double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< double > >::size_type >(val2);
   (arg1)->reserve(arg2);
@@ -11765,7 +11765,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_capacity(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_capacity(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -11778,7 +11778,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_capacity(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_capacity" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_capacity" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = ((std::vector< std::vector< double > > const *)arg1)->capacity();
@@ -11789,7 +11789,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_delete_vdouble2d_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_delete_vdouble2d_T(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -11801,7 +11801,7 @@ SWIGINTERN PyObject *_wrap_delete_vdouble2d_t(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, SWIG_POINTER_DISOWN |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vdouble2d_t" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vdouble2d_T" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   {
@@ -11822,18 +11822,18 @@ fail:
 }
 
 
-SWIGINTERN PyObject *vdouble2d_t_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vdouble2d_T_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   PyObject *obj;
   if (!SWIG_Python_UnpackTuple(args, "swigregister", 1, 1, &obj)) return NULL;
   SWIG_TypeNewClientData(SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, SWIG_NewClientData(obj));
   return SWIG_Py_Void();
 }
 
-SWIGINTERN PyObject *vdouble2d_t_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vdouble2d_T_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   return SWIG_Python_InitShadowInstance(args);
 }
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_iterator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_iterator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   PyObject **arg2 = (PyObject **) 0 ;
@@ -11848,7 +11848,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_iterator(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_iterator" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_iterator" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = (swig::SwigPyIterator *)std_vector_Sl_int_Sg__iterator(arg1,arg2);
@@ -11859,7 +11859,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___nonzero__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___nonzero__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -11872,7 +11872,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___nonzero__(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___nonzero__" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___nonzero__" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = (bool)std_vector_Sl_int_Sg____nonzero__((std::vector< int > const *)arg1);
@@ -11883,7 +11883,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___bool__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___bool__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -11896,7 +11896,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___bool__(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___bool__" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___bool__" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = (bool)std_vector_Sl_int_Sg____bool__((std::vector< int > const *)arg1);
@@ -11907,7 +11907,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___len__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___len__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -11920,7 +11920,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___len__(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___len__" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___len__" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = std_vector_Sl_int_Sg____len__((std::vector< int > const *)arg1);
@@ -11931,7 +11931,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___getslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___getslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::difference_type arg2 ;
@@ -11946,20 +11946,20 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___getslice__(PyObject *self, PyObjec
   std::vector< int,std::allocator< int > > *result = 0 ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_integer_t___getslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_integer_T___getslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___getslice__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___getslice__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t___getslice__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T___getslice__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< int >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_t___getslice__" "', argument " "3"" of type '" "std::vector< int >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_T___getslice__" "', argument " "3"" of type '" "std::vector< int >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< int >::difference_type >(val3);
   try {
@@ -11976,7 +11976,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::difference_type arg2 ;
@@ -11992,17 +11992,17 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setslice____SWIG_0(PyObject *self,
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___setslice__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___setslice__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t___setslice__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T___setslice__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< int >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_t___setslice__" "', argument " "3"" of type '" "std::vector< int >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_T___setslice__" "', argument " "3"" of type '" "std::vector< int >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< int >::difference_type >(val3);
   try {
@@ -12019,7 +12019,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::difference_type arg2 ;
@@ -12037,27 +12037,27 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setslice____SWIG_1(PyObject *self,
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___setslice__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___setslice__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t___setslice__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T___setslice__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< int >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_t___setslice__" "', argument " "3"" of type '" "std::vector< int >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_T___setslice__" "', argument " "3"" of type '" "std::vector< int >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< int >::difference_type >(val3);
   {
     std::vector< int,std::allocator< int > > *ptr = (std::vector< int,std::allocator< int > > *)0;
     res4 = swig::asptr(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_integer_t___setslice__" "', argument " "4"" of type '" "std::vector< int,std::allocator< int > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_integer_T___setslice__" "', argument " "4"" of type '" "std::vector< int,std::allocator< int > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_integer_t___setslice__" "', argument " "4"" of type '" "std::vector< int,std::allocator< int > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_integer_T___setslice__" "', argument " "4"" of type '" "std::vector< int,std::allocator< int > > const &""'"); 
     }
     arg4 = ptr;
   }
@@ -12077,13 +12077,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___setslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___setslice__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_t___setslice__", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_T___setslice__", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -12100,7 +12100,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setslice__(PyObject *self, PyObjec
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_integer_t___setslice____SWIG_0(self, argc, argv);
+          return _wrap_vector_integer_T___setslice____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -12123,7 +12123,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setslice__(PyObject *self, PyObjec
           int res = swig::asptr(argv[3], (std::vector< int,std::allocator< int > >**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vector_integer_t___setslice____SWIG_1(self, argc, argv);
+            return _wrap_vector_integer_T___setslice____SWIG_1(self, argc, argv);
           }
         }
       }
@@ -12131,7 +12131,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setslice__(PyObject *self, PyObjec
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_t___setslice__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_T___setslice__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< int >::__setslice__(std::vector< int >::difference_type,std::vector< int >::difference_type)\n"
     "    std::vector< int >::__setslice__(std::vector< int >::difference_type,std::vector< int >::difference_type,std::vector< int,std::allocator< int > > const &)\n");
@@ -12139,7 +12139,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___delslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___delslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::difference_type arg2 ;
@@ -12153,20 +12153,20 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___delslice__(PyObject *self, PyObjec
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_integer_t___delslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_integer_T___delslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___delslice__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___delslice__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t___delslice__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T___delslice__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< int >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_t___delslice__" "', argument " "3"" of type '" "std::vector< int >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_T___delslice__" "', argument " "3"" of type '" "std::vector< int >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< int >::difference_type >(val3);
   try {
@@ -12183,7 +12183,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::difference_type arg2 ;
@@ -12196,12 +12196,12 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___delitem____SWIG_0(PyObject *self,
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___delitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___delitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t___delitem__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T___delitem__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< int >::difference_type >(val2);
   try {
@@ -12218,7 +12218,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -12230,12 +12230,12 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___getitem____SWIG_0(PyObject *self,
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___getitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___getitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -12253,7 +12253,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -12266,12 +12266,12 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setitem____SWIG_0(PyObject *self,
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___setitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___setitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -12279,10 +12279,10 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setitem____SWIG_0(PyObject *self,
     std::vector< int,std::allocator< int > > *ptr = (std::vector< int,std::allocator< int > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_integer_t___setitem__" "', argument " "3"" of type '" "std::vector< int,std::allocator< int > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_integer_T___setitem__" "', argument " "3"" of type '" "std::vector< int,std::allocator< int > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_integer_t___setitem__" "', argument " "3"" of type '" "std::vector< int,std::allocator< int > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_integer_T___setitem__" "', argument " "3"" of type '" "std::vector< int,std::allocator< int > > const &""'"); 
     }
     arg3 = ptr;
   }
@@ -12302,7 +12302,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -12313,12 +12313,12 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setitem____SWIG_1(PyObject *self,
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___setitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___setitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -12336,7 +12336,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -12347,12 +12347,12 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___delitem____SWIG_1(PyObject *self,
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___delitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___delitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -12370,13 +12370,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___delitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___delitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_t___delitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_T___delitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -12387,7 +12387,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___delitem__(PyObject *self, PyObject
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_integer_t___delitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_integer_T___delitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -12401,13 +12401,13 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___delitem__(PyObject *self, PyObject
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_integer_t___delitem____SWIG_0(self, argc, argv);
+        return _wrap_vector_integer_T___delitem____SWIG_0(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_t___delitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_T___delitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< int >::__delitem__(std::vector< int >::difference_type)\n"
     "    std::vector< int >::__delitem__(SWIGPY_SLICEOBJECT *)\n");
@@ -12415,7 +12415,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::difference_type arg2 ;
@@ -12429,12 +12429,12 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___getitem____SWIG_1(PyObject *self,
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___getitem__" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___getitem__" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t___getitem__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T___getitem__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< int >::difference_type >(val2);
   try {
@@ -12450,13 +12450,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___getitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___getitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_t___getitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_T___getitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -12467,7 +12467,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___getitem__(PyObject *self, PyObject
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_integer_t___getitem____SWIG_0(self, argc, argv);
+        return _wrap_vector_integer_T___getitem____SWIG_0(self, argc, argv);
       }
     }
   }
@@ -12481,13 +12481,13 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___getitem__(PyObject *self, PyObject
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_integer_t___getitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_integer_T___getitem____SWIG_1(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_t___getitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_T___getitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< int >::__getitem__(SWIGPY_SLICEOBJECT *)\n"
     "    std::vector< int >::__getitem__(std::vector< int >::difference_type) const\n");
@@ -12495,7 +12495,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::difference_type arg2 ;
@@ -12512,17 +12512,17 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setitem____SWIG_2(PyObject *self,
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___setitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___setitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t___setitem__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T___setitem__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< int >::difference_type >(val2);
   ecode3 = SWIG_AsVal_int(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_t___setitem__" "', argument " "3"" of type '" "std::vector< int >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_T___setitem__" "', argument " "3"" of type '" "std::vector< int >::value_type""'");
   } 
   temp3 = static_cast< std::vector< int >::value_type >(val3);
   arg3 = &temp3;
@@ -12538,13 +12538,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___setitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___setitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_t___setitem__", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_T___setitem__", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -12555,7 +12555,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setitem__(PyObject *self, PyObject
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_integer_t___setitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_integer_T___setitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -12571,7 +12571,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setitem__(PyObject *self, PyObject
         int res = swig::asptr(argv[2], (std::vector< int,std::allocator< int > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vector_integer_t___setitem____SWIG_0(self, argc, argv);
+          return _wrap_vector_integer_T___setitem____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -12591,14 +12591,14 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setitem__(PyObject *self, PyObject
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_integer_t___setitem____SWIG_2(self, argc, argv);
+          return _wrap_vector_integer_T___setitem____SWIG_2(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_t___setitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_T___setitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< int >::__setitem__(SWIGPY_SLICEOBJECT *,std::vector< int,std::allocator< int > > const &)\n"
     "    std::vector< int >::__setitem__(SWIGPY_SLICEOBJECT *)\n"
@@ -12607,7 +12607,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_pop(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_pop(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -12620,7 +12620,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_pop(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_pop" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_pop" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   try {
@@ -12635,7 +12635,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_append(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_append(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::value_type *arg2 = 0 ;
@@ -12647,15 +12647,15 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_append(PyObject *self, PyObject *arg
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_integer_t_append", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_integer_T_append", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_append" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_append" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_int(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t_append" "', argument " "2"" of type '" "std::vector< int >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T_append" "', argument " "2"" of type '" "std::vector< int >::value_type""'");
   } 
   temp2 = static_cast< std::vector< int >::value_type >(val2);
   arg2 = &temp2;
@@ -12667,7 +12667,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_integer_t__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
+SWIGINTERN PyObject *_wrap_new_vector_integer_T__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
   PyObject *resultobj = 0;
   std::vector< int > *result = 0 ;
   
@@ -12681,7 +12681,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_integer_t__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_integer_T__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = 0 ;
   int res1 = SWIG_OLDOBJ ;
@@ -12693,10 +12693,10 @@ SWIGINTERN PyObject *_wrap_new_vector_integer_t__SWIG_1(PyObject *self, Py_ssize
     std::vector< int,std::allocator< int > > *ptr = (std::vector< int,std::allocator< int > > *)0;
     res1 = swig::asptr(swig_obj[0], &ptr);
     if (!SWIG_IsOK(res1)) {
-      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vector_integer_t" "', argument " "1"" of type '" "std::vector< int > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vector_integer_T" "', argument " "1"" of type '" "std::vector< int > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_integer_t" "', argument " "1"" of type '" "std::vector< int > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_integer_T" "', argument " "1"" of type '" "std::vector< int > const &""'"); 
     }
     arg1 = ptr;
   }
@@ -12710,7 +12710,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_empty(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_empty(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -12723,7 +12723,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_empty(PyObject *self, PyObject *args
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_empty" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_empty" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = (bool)((std::vector< int > const *)arg1)->empty();
@@ -12734,7 +12734,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_size(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_size(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -12747,7 +12747,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_size(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_size" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_size" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = ((std::vector< int > const *)arg1)->size();
@@ -12758,7 +12758,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_swap(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_swap(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int > *arg2 = 0 ;
@@ -12769,18 +12769,18 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_swap(PyObject *self, PyObject *args)
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_integer_t_swap", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_integer_T_swap", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_swap" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_swap" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], &argp2, SWIGTYPE_p_std__vectorT_int_t,  0 );
   if (!SWIG_IsOK(res2)) {
-    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_integer_t_swap" "', argument " "2"" of type '" "std::vector< int > &""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_integer_T_swap" "', argument " "2"" of type '" "std::vector< int > &""'"); 
   }
   if (!argp2) {
-    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_integer_t_swap" "', argument " "2"" of type '" "std::vector< int > &""'"); 
+    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_integer_T_swap" "', argument " "2"" of type '" "std::vector< int > &""'"); 
   }
   arg2 = reinterpret_cast< std::vector< int > * >(argp2);
   (arg1)->swap(*arg2);
@@ -12791,7 +12791,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_begin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_begin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -12804,7 +12804,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_begin(PyObject *self, PyObject *args
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_begin" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_begin" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = (arg1)->begin();
@@ -12816,7 +12816,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_end(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_end(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -12829,7 +12829,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_end(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_end" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_end" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = (arg1)->end();
@@ -12841,7 +12841,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_rbegin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_rbegin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -12854,7 +12854,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_rbegin(PyObject *self, PyObject *arg
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_rbegin" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_rbegin" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = (arg1)->rbegin();
@@ -12866,7 +12866,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_rend(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_rend(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -12879,7 +12879,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_rend(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_rend" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_rend" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = (arg1)->rend();
@@ -12891,7 +12891,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_clear(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_clear(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -12903,7 +12903,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_clear(PyObject *self, PyObject *args
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_clear" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_clear" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   (arg1)->clear();
@@ -12914,7 +12914,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_get_allocator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_get_allocator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -12927,7 +12927,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_get_allocator(PyObject *self, PyObje
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_get_allocator" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_get_allocator" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = ((std::vector< int > const *)arg1)->get_allocator();
@@ -12938,7 +12938,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_integer_t__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_integer_T__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int >::size_type arg1 ;
   size_t val1 ;
@@ -12949,7 +12949,7 @@ SWIGINTERN PyObject *_wrap_new_vector_integer_t__SWIG_2(PyObject *self, Py_ssize
   if ((nobjs < 1) || (nobjs > 1)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_integer_t" "', argument " "1"" of type '" "std::vector< int >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_integer_T" "', argument " "1"" of type '" "std::vector< int >::size_type""'");
   } 
   arg1 = static_cast< std::vector< int >::size_type >(val1);
   result = (std::vector< int > *)new std::vector< int >(arg1);
@@ -12960,7 +12960,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_pop_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_pop_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -12972,7 +12972,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_pop_back(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_pop_back" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_pop_back" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   (arg1)->pop_back();
@@ -12983,7 +12983,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::size_type arg2 ;
@@ -12996,12 +12996,12 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_resize__SWIG_0(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_resize" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_resize" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t_resize" "', argument " "2"" of type '" "std::vector< int >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T_resize" "', argument " "2"" of type '" "std::vector< int >::size_type""'");
   } 
   arg2 = static_cast< std::vector< int >::size_type >(val2);
   (arg1)->resize(arg2);
@@ -13012,7 +13012,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::iterator arg2 ;
@@ -13026,18 +13026,18 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_erase__SWIG_0(PyObject *self, Py_ssi
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_erase" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_erase" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t_erase" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T_erase" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< int >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< int >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t_erase" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T_erase" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
     }
   }
   result = std_vector_Sl_int_Sg__erase__SWIG_0(arg1,SWIG_STD_MOVE(arg2));
@@ -13049,7 +13049,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::iterator arg2 ;
@@ -13066,29 +13066,29 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_erase__SWIG_1(PyObject *self, Py_ssi
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_erase" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_erase" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t_erase" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T_erase" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< int >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< int >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t_erase" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T_erase" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
     }
   }
   res3 = SWIG_ConvertPtr(swig_obj[2], SWIG_as_voidptrptr(&iter3), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res3) || !iter3) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t_erase" "', argument " "3"" of type '" "std::vector< int >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T_erase" "', argument " "3"" of type '" "std::vector< int >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< int >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< int >::iterator > *>(iter3);
     if (iter_t) {
       arg3 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t_erase" "', argument " "3"" of type '" "std::vector< int >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T_erase" "', argument " "3"" of type '" "std::vector< int >::iterator""'");
     }
   }
   result = std_vector_Sl_int_Sg__erase__SWIG_1(arg1,SWIG_STD_MOVE(arg2),SWIG_STD_MOVE(arg3));
@@ -13100,13 +13100,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_erase(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_erase(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_t_erase", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_T_erase", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -13117,7 +13117,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_erase(PyObject *self, PyObject *args
       int res = SWIG_ConvertPtr(argv[1], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
       _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< int >::iterator > *>(iter) != 0));
       if (_v) {
-        return _wrap_vector_integer_t_erase__SWIG_0(self, argc, argv);
+        return _wrap_vector_integer_T_erase__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -13134,14 +13134,14 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_erase(PyObject *self, PyObject *args
         int res = SWIG_ConvertPtr(argv[2], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
         _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< int >::iterator > *>(iter) != 0));
         if (_v) {
-          return _wrap_vector_integer_t_erase__SWIG_1(self, argc, argv);
+          return _wrap_vector_integer_T_erase__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_t_erase'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_T_erase'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< int >::erase(std::vector< int >::iterator)\n"
     "    std::vector< int >::erase(std::vector< int >::iterator,std::vector< int >::iterator)\n");
@@ -13149,7 +13149,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_integer_t__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_integer_T__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int >::size_type arg1 ;
   std::vector< int >::value_type *arg2 = 0 ;
@@ -13164,12 +13164,12 @@ SWIGINTERN PyObject *_wrap_new_vector_integer_t__SWIG_3(PyObject *self, Py_ssize
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_integer_t" "', argument " "1"" of type '" "std::vector< int >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_integer_T" "', argument " "1"" of type '" "std::vector< int >::size_type""'");
   } 
   arg1 = static_cast< std::vector< int >::size_type >(val1);
   ecode2 = SWIG_AsVal_int(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "new_vector_integer_t" "', argument " "2"" of type '" "std::vector< int >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "new_vector_integer_T" "', argument " "2"" of type '" "std::vector< int >::value_type""'");
   } 
   temp2 = static_cast< std::vector< int >::value_type >(val2);
   arg2 = &temp2;
@@ -13181,16 +13181,16 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_integer_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_new_vector_integer_T(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vector_integer_t", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vector_integer_T", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 0) {
-    return _wrap_new_vector_integer_t__SWIG_0(self, argc, argv);
+    return _wrap_new_vector_integer_T__SWIG_0(self, argc, argv);
   }
   if (argc == 1) {
     int _v = 0;
@@ -13199,7 +13199,7 @@ SWIGINTERN PyObject *_wrap_new_vector_integer_t(PyObject *self, PyObject *args)
       _v = SWIG_CheckState(res);
     }
     if (_v) {
-      return _wrap_new_vector_integer_t__SWIG_2(self, argc, argv);
+      return _wrap_new_vector_integer_T__SWIG_2(self, argc, argv);
     }
   }
   if (argc == 1) {
@@ -13207,7 +13207,7 @@ SWIGINTERN PyObject *_wrap_new_vector_integer_t(PyObject *self, PyObject *args)
     int res = swig::asptr(argv[0], (std::vector< int,std::allocator< int > >**)(0));
     _v = SWIG_CheckState(res);
     if (_v) {
-      return _wrap_new_vector_integer_t__SWIG_1(self, argc, argv);
+      return _wrap_new_vector_integer_T__SWIG_1(self, argc, argv);
     }
   }
   if (argc == 2) {
@@ -13222,13 +13222,13 @@ SWIGINTERN PyObject *_wrap_new_vector_integer_t(PyObject *self, PyObject *args)
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_new_vector_integer_t__SWIG_3(self, argc, argv);
+        return _wrap_new_vector_integer_T__SWIG_3(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vector_integer_t'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vector_integer_T'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< int >::vector()\n"
     "    std::vector< int >::vector(std::vector< int > const &)\n"
@@ -13238,7 +13238,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_push_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_push_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::value_type *arg2 = 0 ;
@@ -13250,15 +13250,15 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_push_back(PyObject *self, PyObject *
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_integer_t_push_back", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_integer_T_push_back", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_push_back" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_push_back" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_int(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t_push_back" "', argument " "2"" of type '" "std::vector< int >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T_push_back" "', argument " "2"" of type '" "std::vector< int >::value_type""'");
   } 
   temp2 = static_cast< std::vector< int >::value_type >(val2);
   arg2 = &temp2;
@@ -13270,7 +13270,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_front(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_front(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -13283,7 +13283,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_front(PyObject *self, PyObject *args
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_front" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_front" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = (std::vector< int >::value_type *) &((std::vector< int > const *)arg1)->front();
@@ -13295,7 +13295,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -13308,7 +13308,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_back(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_back" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_back" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = (std::vector< int >::value_type *) &((std::vector< int > const *)arg1)->back();
@@ -13320,7 +13320,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_assign(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_assign(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::size_type arg2 ;
@@ -13335,20 +13335,20 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_assign(PyObject *self, PyObject *arg
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_integer_t_assign", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_integer_T_assign", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_assign" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_assign" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t_assign" "', argument " "2"" of type '" "std::vector< int >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T_assign" "', argument " "2"" of type '" "std::vector< int >::size_type""'");
   } 
   arg2 = static_cast< std::vector< int >::size_type >(val2);
   ecode3 = SWIG_AsVal_int(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_t_assign" "', argument " "3"" of type '" "std::vector< int >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_T_assign" "', argument " "3"" of type '" "std::vector< int >::value_type""'");
   } 
   temp3 = static_cast< std::vector< int >::value_type >(val3);
   arg3 = &temp3;
@@ -13360,7 +13360,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::size_type arg2 ;
@@ -13377,17 +13377,17 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_resize__SWIG_1(PyObject *self, Py_ss
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_resize" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_resize" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t_resize" "', argument " "2"" of type '" "std::vector< int >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T_resize" "', argument " "2"" of type '" "std::vector< int >::size_type""'");
   } 
   arg2 = static_cast< std::vector< int >::size_type >(val2);
   ecode3 = SWIG_AsVal_int(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_t_resize" "', argument " "3"" of type '" "std::vector< int >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_T_resize" "', argument " "3"" of type '" "std::vector< int >::value_type""'");
   } 
   temp3 = static_cast< std::vector< int >::value_type >(val3);
   arg3 = &temp3;
@@ -13399,13 +13399,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_resize(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_resize(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_t_resize", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_T_resize", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -13417,7 +13417,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_resize(PyObject *self, PyObject *arg
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_integer_t_resize__SWIG_0(self, argc, argv);
+        return _wrap_vector_integer_T_resize__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -13436,14 +13436,14 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_resize(PyObject *self, PyObject *arg
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_integer_t_resize__SWIG_1(self, argc, argv);
+          return _wrap_vector_integer_T_resize__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_t_resize'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_T_resize'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< int >::resize(std::vector< int >::size_type)\n"
     "    std::vector< int >::resize(std::vector< int >::size_type,std::vector< int >::value_type const &)\n");
@@ -13451,7 +13451,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::iterator arg2 ;
@@ -13469,23 +13469,23 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_insert__SWIG_0(PyObject *self, Py_ss
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_insert" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_insert" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t_insert" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T_insert" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< int >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< int >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t_insert" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T_insert" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_int(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_t_insert" "', argument " "3"" of type '" "std::vector< int >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_T_insert" "', argument " "3"" of type '" "std::vector< int >::value_type""'");
   } 
   temp3 = static_cast< std::vector< int >::value_type >(val3);
   arg3 = &temp3;
@@ -13498,7 +13498,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::iterator arg2 ;
@@ -13518,28 +13518,28 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_insert__SWIG_1(PyObject *self, Py_ss
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_insert" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_insert" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t_insert" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T_insert" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< int >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< int >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t_insert" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T_insert" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_size_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_t_insert" "', argument " "3"" of type '" "std::vector< int >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_T_insert" "', argument " "3"" of type '" "std::vector< int >::size_type""'");
   } 
   arg3 = static_cast< std::vector< int >::size_type >(val3);
   ecode4 = SWIG_AsVal_int(swig_obj[3], &val4);
   if (!SWIG_IsOK(ecode4)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode4), "in method '" "vector_integer_t_insert" "', argument " "4"" of type '" "std::vector< int >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode4), "in method '" "vector_integer_T_insert" "', argument " "4"" of type '" "std::vector< int >::value_type""'");
   } 
   temp4 = static_cast< std::vector< int >::value_type >(val4);
   arg4 = &temp4;
@@ -13551,13 +13551,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_insert(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_insert(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_t_insert", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_T_insert", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -13573,7 +13573,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_insert(PyObject *self, PyObject *arg
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_integer_t_insert__SWIG_0(self, argc, argv);
+          return _wrap_vector_integer_T_insert__SWIG_0(self, argc, argv);
         }
       }
     }
@@ -13597,7 +13597,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_insert(PyObject *self, PyObject *arg
             _v = SWIG_CheckState(res);
           }
           if (_v) {
-            return _wrap_vector_integer_t_insert__SWIG_1(self, argc, argv);
+            return _wrap_vector_integer_T_insert__SWIG_1(self, argc, argv);
           }
         }
       }
@@ -13605,7 +13605,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_insert(PyObject *self, PyObject *arg
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_t_insert'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_T_insert'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< int >::insert(std::vector< int >::iterator,std::vector< int >::value_type const &)\n"
     "    std::vector< int >::insert(std::vector< int >::iterator,std::vector< int >::size_type,std::vector< int >::value_type const &)\n");
@@ -13613,7 +13613,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_reserve(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_reserve(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::size_type arg2 ;
@@ -13624,15 +13624,15 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_reserve(PyObject *self, PyObject *ar
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_integer_t_reserve", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_integer_T_reserve", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_reserve" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_reserve" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t_reserve" "', argument " "2"" of type '" "std::vector< int >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T_reserve" "', argument " "2"" of type '" "std::vector< int >::size_type""'");
   } 
   arg2 = static_cast< std::vector< int >::size_type >(val2);
   (arg1)->reserve(arg2);
@@ -13643,7 +13643,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_capacity(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_capacity(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -13656,7 +13656,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_capacity(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_capacity" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_capacity" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = ((std::vector< int > const *)arg1)->capacity();
@@ -13667,7 +13667,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_delete_vector_integer_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_delete_vector_integer_T(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -13679,7 +13679,7 @@ SWIGINTERN PyObject *_wrap_delete_vector_integer_t(PyObject *self, PyObject *arg
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, SWIG_POINTER_DISOWN |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vector_integer_t" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vector_integer_T" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   {
@@ -13700,18 +13700,18 @@ fail:
 }
 
 
-SWIGINTERN PyObject *vector_integer_t_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vector_integer_T_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   PyObject *obj;
   if (!SWIG_Python_UnpackTuple(args, "swigregister", 1, 1, &obj)) return NULL;
   SWIG_TypeNewClientData(SWIGTYPE_p_std__vectorT_int_t, SWIG_NewClientData(obj));
   return SWIG_Py_Void();
 }
 
-SWIGINTERN PyObject *vector_integer_t_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vector_integer_T_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   return SWIG_Python_InitShadowInstance(args);
 }
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_iterator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_iterator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   PyObject **arg2 = (PyObject **) 0 ;
@@ -13726,7 +13726,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_iterator(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_iterator" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_iterator" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = (swig::SwigPyIterator *)std_vector_Sl_std_vector_Sl_int_Sg__Sg__iterator(arg1,arg2);
@@ -13737,7 +13737,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___nonzero__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___nonzero__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -13750,7 +13750,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___nonzero__(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___nonzero__" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___nonzero__" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = (bool)std_vector_Sl_std_vector_Sl_int_Sg__Sg____nonzero__((std::vector< std::vector< int > > const *)arg1);
@@ -13761,7 +13761,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___bool__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___bool__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -13774,7 +13774,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___bool__(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___bool__" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___bool__" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = (bool)std_vector_Sl_std_vector_Sl_int_Sg__Sg____bool__((std::vector< std::vector< int > > const *)arg1);
@@ -13785,7 +13785,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___len__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___len__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -13798,7 +13798,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___len__(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___len__" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___len__" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = std_vector_Sl_std_vector_Sl_int_Sg__Sg____len__((std::vector< std::vector< int > > const *)arg1);
@@ -13809,7 +13809,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___getslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___getslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::difference_type arg2 ;
@@ -13824,20 +13824,20 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___getslice__(PyObject *self, PyObject *a
   std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > *result = 0 ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_t___getslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_T___getslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___getslice__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___getslice__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_t___getslice__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_T___getslice__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< int > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vinteger2d_t___getslice__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vinteger2d_T___getslice__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::vector< int > >::difference_type >(val3);
   try {
@@ -13854,7 +13854,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::difference_type arg2 ;
@@ -13870,17 +13870,17 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setslice____SWIG_0(PyObject *self, Py_
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___setslice__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___setslice__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_t___setslice__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_T___setslice__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< int > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vinteger2d_t___setslice__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vinteger2d_T___setslice__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::vector< int > >::difference_type >(val3);
   try {
@@ -13897,7 +13897,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::difference_type arg2 ;
@@ -13915,27 +13915,27 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setslice____SWIG_1(PyObject *self, Py_
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___setslice__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___setslice__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_t___setslice__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_T___setslice__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< int > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vinteger2d_t___setslice__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vinteger2d_T___setslice__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::vector< int > >::difference_type >(val3);
   {
     std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > *ptr = (std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > *)0;
     res4 = swig::asptr(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vinteger2d_t___setslice__" "', argument " "4"" of type '" "std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vinteger2d_T___setslice__" "', argument " "4"" of type '" "std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_t___setslice__" "', argument " "4"" of type '" "std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_T___setslice__" "', argument " "4"" of type '" "std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > const &""'"); 
     }
     arg4 = ptr;
   }
@@ -13955,13 +13955,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___setslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___setslice__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_t___setslice__", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_T___setslice__", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -13978,7 +13978,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setslice__(PyObject *self, PyObject *a
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vinteger2d_t___setslice____SWIG_0(self, argc, argv);
+          return _wrap_vinteger2d_T___setslice____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -14001,7 +14001,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setslice__(PyObject *self, PyObject *a
           int res = swig::asptr(argv[3], (std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > >**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vinteger2d_t___setslice____SWIG_1(self, argc, argv);
+            return _wrap_vinteger2d_T___setslice____SWIG_1(self, argc, argv);
           }
         }
       }
@@ -14009,7 +14009,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setslice__(PyObject *self, PyObject *a
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_t___setslice__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_T___setslice__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< int > >::__setslice__(std::vector< std::vector< int > >::difference_type,std::vector< std::vector< int > >::difference_type)\n"
     "    std::vector< std::vector< int > >::__setslice__(std::vector< std::vector< int > >::difference_type,std::vector< std::vector< int > >::difference_type,std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > const &)\n");
@@ -14017,7 +14017,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___delslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___delslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::difference_type arg2 ;
@@ -14031,20 +14031,20 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___delslice__(PyObject *self, PyObject *a
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_t___delslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_T___delslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___delslice__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___delslice__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_t___delslice__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_T___delslice__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< int > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vinteger2d_t___delslice__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vinteger2d_T___delslice__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::vector< int > >::difference_type >(val3);
   try {
@@ -14061,7 +14061,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::difference_type arg2 ;
@@ -14074,12 +14074,12 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___delitem____SWIG_0(PyObject *self, Py_s
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___delitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___delitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_t___delitem__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_T___delitem__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< int > >::difference_type >(val2);
   try {
@@ -14096,7 +14096,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -14108,12 +14108,12 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___getitem____SWIG_0(PyObject *self, Py_s
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___getitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___getitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -14131,7 +14131,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -14144,12 +14144,12 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setitem____SWIG_0(PyObject *self, Py_s
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -14157,10 +14157,10 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setitem____SWIG_0(PyObject *self, Py_s
     std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > *ptr = (std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vinteger2d_t___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vinteger2d_T___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_t___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_T___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > const &""'"); 
     }
     arg3 = ptr;
   }
@@ -14180,7 +14180,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -14191,12 +14191,12 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setitem____SWIG_1(PyObject *self, Py_s
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -14214,7 +14214,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -14225,12 +14225,12 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___delitem____SWIG_1(PyObject *self, Py_s
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___delitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___delitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -14248,13 +14248,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___delitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___delitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_t___delitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_T___delitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -14265,7 +14265,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___delitem__(PyObject *self, PyObject *ar
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vinteger2d_t___delitem____SWIG_1(self, argc, argv);
+        return _wrap_vinteger2d_T___delitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -14279,13 +14279,13 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___delitem__(PyObject *self, PyObject *ar
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vinteger2d_t___delitem____SWIG_0(self, argc, argv);
+        return _wrap_vinteger2d_T___delitem____SWIG_0(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_t___delitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_T___delitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< int > >::__delitem__(std::vector< std::vector< int > >::difference_type)\n"
     "    std::vector< std::vector< int > >::__delitem__(SWIGPY_SLICEOBJECT *)\n");
@@ -14293,7 +14293,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::difference_type arg2 ;
@@ -14307,12 +14307,12 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___getitem____SWIG_1(PyObject *self, Py_s
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___getitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___getitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_t___getitem__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_T___getitem__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< int > >::difference_type >(val2);
   try {
@@ -14328,13 +14328,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___getitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___getitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_t___getitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_T___getitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -14345,7 +14345,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___getitem__(PyObject *self, PyObject *ar
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vinteger2d_t___getitem____SWIG_0(self, argc, argv);
+        return _wrap_vinteger2d_T___getitem____SWIG_0(self, argc, argv);
       }
     }
   }
@@ -14359,13 +14359,13 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___getitem__(PyObject *self, PyObject *ar
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vinteger2d_t___getitem____SWIG_1(self, argc, argv);
+        return _wrap_vinteger2d_T___getitem____SWIG_1(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_t___getitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_T___getitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< int > >::__getitem__(SWIGPY_SLICEOBJECT *)\n"
     "    std::vector< std::vector< int > >::__getitem__(std::vector< std::vector< int > >::difference_type) const\n");
@@ -14373,7 +14373,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::difference_type arg2 ;
@@ -14388,22 +14388,22 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setitem____SWIG_2(PyObject *self, Py_s
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_t___setitem__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_T___setitem__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< int > >::difference_type >(val2);
   {
     std::vector< int,std::allocator< int > > *ptr = (std::vector< int,std::allocator< int > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vinteger2d_t___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vinteger2d_T___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_t___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_T___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -14421,13 +14421,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___setitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___setitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_t___setitem__", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_T___setitem__", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -14438,7 +14438,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setitem__(PyObject *self, PyObject *ar
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vinteger2d_t___setitem____SWIG_1(self, argc, argv);
+        return _wrap_vinteger2d_T___setitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -14454,7 +14454,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setitem__(PyObject *self, PyObject *ar
         int res = swig::asptr(argv[2], (std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vinteger2d_t___setitem____SWIG_0(self, argc, argv);
+          return _wrap_vinteger2d_T___setitem____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -14472,14 +14472,14 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setitem__(PyObject *self, PyObject *ar
         int res = swig::asptr(argv[2], (std::vector< int,std::allocator< int > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vinteger2d_t___setitem____SWIG_2(self, argc, argv);
+          return _wrap_vinteger2d_T___setitem____SWIG_2(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_t___setitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_T___setitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< int > >::__setitem__(SWIGPY_SLICEOBJECT *,std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > const &)\n"
     "    std::vector< std::vector< int > >::__setitem__(SWIGPY_SLICEOBJECT *)\n"
@@ -14488,7 +14488,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_pop(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_pop(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -14501,7 +14501,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_pop(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_pop" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_pop" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   try {
@@ -14516,7 +14516,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_append(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_append(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::value_type *arg2 = 0 ;
@@ -14526,20 +14526,20 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_append(PyObject *self, PyObject *args) {
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_t_append", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_T_append", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_append" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_append" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   {
     std::vector< int,std::allocator< int > > *ptr = (std::vector< int,std::allocator< int > > *)0;
     res2 = swig::asptr(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vinteger2d_t_append" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vinteger2d_T_append" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_t_append" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_T_append" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -14553,7 +14553,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vinteger2d_t__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
+SWIGINTERN PyObject *_wrap_new_vinteger2d_T__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *result = 0 ;
   
@@ -14567,7 +14567,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vinteger2d_t__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vinteger2d_T__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int,std::allocator< int > > > *arg1 = 0 ;
   int res1 = SWIG_OLDOBJ ;
@@ -14579,10 +14579,10 @@ SWIGINTERN PyObject *_wrap_new_vinteger2d_t__SWIG_1(PyObject *self, Py_ssize_t n
     std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > *ptr = (std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > *)0;
     res1 = swig::asptr(swig_obj[0], &ptr);
     if (!SWIG_IsOK(res1)) {
-      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vinteger2d_t" "', argument " "1"" of type '" "std::vector< std::vector< int,std::allocator< int > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vinteger2d_T" "', argument " "1"" of type '" "std::vector< std::vector< int,std::allocator< int > > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vinteger2d_t" "', argument " "1"" of type '" "std::vector< std::vector< int,std::allocator< int > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vinteger2d_T" "', argument " "1"" of type '" "std::vector< std::vector< int,std::allocator< int > > > const &""'"); 
     }
     arg1 = ptr;
   }
@@ -14596,7 +14596,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_empty(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_empty(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -14609,7 +14609,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_empty(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_empty" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_empty" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = (bool)((std::vector< std::vector< int > > const *)arg1)->empty();
@@ -14620,7 +14620,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_size(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_size(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -14633,7 +14633,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_size(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_size" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_size" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = ((std::vector< std::vector< int > > const *)arg1)->size();
@@ -14644,7 +14644,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_swap(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_swap(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int,std::allocator< int > > > *arg2 = 0 ;
@@ -14655,18 +14655,18 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_swap(PyObject *self, PyObject *args) {
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_t_swap", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_T_swap", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_swap" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_swap" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], &argp2, SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t,  0 );
   if (!SWIG_IsOK(res2)) {
-    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vinteger2d_t_swap" "', argument " "2"" of type '" "std::vector< std::vector< int,std::allocator< int > > > &""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vinteger2d_T_swap" "', argument " "2"" of type '" "std::vector< std::vector< int,std::allocator< int > > > &""'"); 
   }
   if (!argp2) {
-    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_t_swap" "', argument " "2"" of type '" "std::vector< std::vector< int,std::allocator< int > > > &""'"); 
+    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_T_swap" "', argument " "2"" of type '" "std::vector< std::vector< int,std::allocator< int > > > &""'"); 
   }
   arg2 = reinterpret_cast< std::vector< std::vector< int,std::allocator< int > > > * >(argp2);
   (arg1)->swap(*arg2);
@@ -14677,7 +14677,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_begin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_begin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -14690,7 +14690,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_begin(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_begin" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_begin" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = (arg1)->begin();
@@ -14702,7 +14702,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_end(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_end(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -14715,7 +14715,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_end(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_end" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_end" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = (arg1)->end();
@@ -14727,7 +14727,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_rbegin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_rbegin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -14740,7 +14740,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_rbegin(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_rbegin" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_rbegin" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = (arg1)->rbegin();
@@ -14752,7 +14752,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_rend(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_rend(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -14765,7 +14765,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_rend(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_rend" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_rend" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = (arg1)->rend();
@@ -14777,7 +14777,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_clear(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_clear(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -14789,7 +14789,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_clear(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_clear" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_clear" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   (arg1)->clear();
@@ -14800,7 +14800,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_get_allocator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_get_allocator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -14813,7 +14813,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_get_allocator(PyObject *self, PyObject *
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_get_allocator" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_get_allocator" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = ((std::vector< std::vector< int > > const *)arg1)->get_allocator();
@@ -14824,7 +14824,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vinteger2d_t__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vinteger2d_T__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > >::size_type arg1 ;
   size_t val1 ;
@@ -14835,7 +14835,7 @@ SWIGINTERN PyObject *_wrap_new_vinteger2d_t__SWIG_2(PyObject *self, Py_ssize_t n
   if ((nobjs < 1) || (nobjs > 1)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vinteger2d_t" "', argument " "1"" of type '" "std::vector< std::vector< int > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vinteger2d_T" "', argument " "1"" of type '" "std::vector< std::vector< int > >::size_type""'");
   } 
   arg1 = static_cast< std::vector< std::vector< int > >::size_type >(val1);
   result = (std::vector< std::vector< int > > *)new std::vector< std::vector< int > >(arg1);
@@ -14846,7 +14846,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_pop_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_pop_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -14858,7 +14858,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_pop_back(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_pop_back" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_pop_back" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   (arg1)->pop_back();
@@ -14869,7 +14869,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::size_type arg2 ;
@@ -14882,12 +14882,12 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_resize__SWIG_0(PyObject *self, Py_ssize_
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_resize" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_resize" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_t_resize" "', argument " "2"" of type '" "std::vector< std::vector< int > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_T_resize" "', argument " "2"" of type '" "std::vector< std::vector< int > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< int > >::size_type >(val2);
   (arg1)->resize(arg2);
@@ -14898,7 +14898,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::iterator arg2 ;
@@ -14912,18 +14912,18 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_erase__SWIG_0(PyObject *self, Py_ssize_t
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_erase" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_erase" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t_erase" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T_erase" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t_erase" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T_erase" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
     }
   }
   result = std_vector_Sl_std_vector_Sl_int_Sg__Sg__erase__SWIG_0(arg1,SWIG_STD_MOVE(arg2));
@@ -14935,7 +14935,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::iterator arg2 ;
@@ -14952,29 +14952,29 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_erase__SWIG_1(PyObject *self, Py_ssize_t
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_erase" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_erase" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t_erase" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T_erase" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t_erase" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T_erase" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
     }
   }
   res3 = SWIG_ConvertPtr(swig_obj[2], SWIG_as_voidptrptr(&iter3), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res3) || !iter3) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t_erase" "', argument " "3"" of type '" "std::vector< std::vector< int > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T_erase" "', argument " "3"" of type '" "std::vector< std::vector< int > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *>(iter3);
     if (iter_t) {
       arg3 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t_erase" "', argument " "3"" of type '" "std::vector< std::vector< int > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T_erase" "', argument " "3"" of type '" "std::vector< std::vector< int > >::iterator""'");
     }
   }
   result = std_vector_Sl_std_vector_Sl_int_Sg__Sg__erase__SWIG_1(arg1,SWIG_STD_MOVE(arg2),SWIG_STD_MOVE(arg3));
@@ -14986,13 +14986,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_erase(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_erase(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_t_erase", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_T_erase", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -15003,7 +15003,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_erase(PyObject *self, PyObject *args) {
       int res = SWIG_ConvertPtr(argv[1], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
       _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *>(iter) != 0));
       if (_v) {
-        return _wrap_vinteger2d_t_erase__SWIG_0(self, argc, argv);
+        return _wrap_vinteger2d_T_erase__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -15020,14 +15020,14 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_erase(PyObject *self, PyObject *args) {
         int res = SWIG_ConvertPtr(argv[2], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
         _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *>(iter) != 0));
         if (_v) {
-          return _wrap_vinteger2d_t_erase__SWIG_1(self, argc, argv);
+          return _wrap_vinteger2d_T_erase__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_t_erase'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_T_erase'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< int > >::erase(std::vector< std::vector< int > >::iterator)\n"
     "    std::vector< std::vector< int > >::erase(std::vector< std::vector< int > >::iterator,std::vector< std::vector< int > >::iterator)\n");
@@ -15035,7 +15035,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vinteger2d_t__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vinteger2d_T__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > >::size_type arg1 ;
   std::vector< std::vector< int > >::value_type *arg2 = 0 ;
@@ -15048,17 +15048,17 @@ SWIGINTERN PyObject *_wrap_new_vinteger2d_t__SWIG_3(PyObject *self, Py_ssize_t n
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vinteger2d_t" "', argument " "1"" of type '" "std::vector< std::vector< int > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vinteger2d_T" "', argument " "1"" of type '" "std::vector< std::vector< int > >::size_type""'");
   } 
   arg1 = static_cast< std::vector< std::vector< int > >::size_type >(val1);
   {
     std::vector< int,std::allocator< int > > *ptr = (std::vector< int,std::allocator< int > > *)0;
     res2 = swig::asptr(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "new_vinteger2d_t" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "new_vinteger2d_T" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vinteger2d_t" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vinteger2d_T" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -15072,16 +15072,16 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vinteger2d_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_new_vinteger2d_T(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vinteger2d_t", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vinteger2d_T", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 0) {
-    return _wrap_new_vinteger2d_t__SWIG_0(self, argc, argv);
+    return _wrap_new_vinteger2d_T__SWIG_0(self, argc, argv);
   }
   if (argc == 1) {
     int _v = 0;
@@ -15090,7 +15090,7 @@ SWIGINTERN PyObject *_wrap_new_vinteger2d_t(PyObject *self, PyObject *args) {
       _v = SWIG_CheckState(res);
     }
     if (_v) {
-      return _wrap_new_vinteger2d_t__SWIG_2(self, argc, argv);
+      return _wrap_new_vinteger2d_T__SWIG_2(self, argc, argv);
     }
   }
   if (argc == 1) {
@@ -15098,7 +15098,7 @@ SWIGINTERN PyObject *_wrap_new_vinteger2d_t(PyObject *self, PyObject *args) {
     int res = swig::asptr(argv[0], (std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > >**)(0));
     _v = SWIG_CheckState(res);
     if (_v) {
-      return _wrap_new_vinteger2d_t__SWIG_1(self, argc, argv);
+      return _wrap_new_vinteger2d_T__SWIG_1(self, argc, argv);
     }
   }
   if (argc == 2) {
@@ -15111,13 +15111,13 @@ SWIGINTERN PyObject *_wrap_new_vinteger2d_t(PyObject *self, PyObject *args) {
       int res = swig::asptr(argv[1], (std::vector< int,std::allocator< int > >**)(0));
       _v = SWIG_CheckState(res);
       if (_v) {
-        return _wrap_new_vinteger2d_t__SWIG_3(self, argc, argv);
+        return _wrap_new_vinteger2d_T__SWIG_3(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vinteger2d_t'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vinteger2d_T'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< int > >::vector()\n"
     "    std::vector< std::vector< int > >::vector(std::vector< std::vector< int,std::allocator< int > > > const &)\n"
@@ -15127,7 +15127,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_push_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_push_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::value_type *arg2 = 0 ;
@@ -15137,20 +15137,20 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_push_back(PyObject *self, PyObject *args
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_t_push_back", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_T_push_back", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_push_back" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_push_back" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   {
     std::vector< int,std::allocator< int > > *ptr = (std::vector< int,std::allocator< int > > *)0;
     res2 = swig::asptr(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vinteger2d_t_push_back" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vinteger2d_T_push_back" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_t_push_back" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_T_push_back" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -15164,7 +15164,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_front(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_front(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -15177,7 +15177,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_front(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_front" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_front" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = (std::vector< std::vector< int > >::value_type *) &((std::vector< std::vector< int > > const *)arg1)->front();
@@ -15189,7 +15189,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -15202,7 +15202,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_back(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_back" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_back" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = (std::vector< std::vector< int > >::value_type *) &((std::vector< std::vector< int > > const *)arg1)->back();
@@ -15214,7 +15214,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_assign(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_assign(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::size_type arg2 ;
@@ -15227,25 +15227,25 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_assign(PyObject *self, PyObject *args) {
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_t_assign", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_T_assign", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_assign" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_assign" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_t_assign" "', argument " "2"" of type '" "std::vector< std::vector< int > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_T_assign" "', argument " "2"" of type '" "std::vector< std::vector< int > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< int > >::size_type >(val2);
   {
     std::vector< int,std::allocator< int > > *ptr = (std::vector< int,std::allocator< int > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vinteger2d_t_assign" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vinteger2d_T_assign" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_t_assign" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_T_assign" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -15259,7 +15259,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::size_type arg2 ;
@@ -15274,22 +15274,22 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_resize__SWIG_1(PyObject *self, Py_ssize_
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_resize" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_resize" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_t_resize" "', argument " "2"" of type '" "std::vector< std::vector< int > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_T_resize" "', argument " "2"" of type '" "std::vector< std::vector< int > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< int > >::size_type >(val2);
   {
     std::vector< int,std::allocator< int > > *ptr = (std::vector< int,std::allocator< int > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vinteger2d_t_resize" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vinteger2d_T_resize" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_t_resize" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_T_resize" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -15303,13 +15303,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_resize(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_resize(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_t_resize", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_T_resize", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -15321,7 +15321,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_resize(PyObject *self, PyObject *args) {
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vinteger2d_t_resize__SWIG_0(self, argc, argv);
+        return _wrap_vinteger2d_T_resize__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -15338,14 +15338,14 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_resize(PyObject *self, PyObject *args) {
         int res = swig::asptr(argv[2], (std::vector< int,std::allocator< int > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vinteger2d_t_resize__SWIG_1(self, argc, argv);
+          return _wrap_vinteger2d_T_resize__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_t_resize'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_T_resize'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< int > >::resize(std::vector< std::vector< int > >::size_type)\n"
     "    std::vector< std::vector< int > >::resize(std::vector< std::vector< int > >::size_type,std::vector< std::vector< int > >::value_type const &)\n");
@@ -15353,7 +15353,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::iterator arg2 ;
@@ -15369,28 +15369,28 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_insert__SWIG_0(PyObject *self, Py_ssize_
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_insert" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_insert" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t_insert" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T_insert" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t_insert" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T_insert" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
     }
   }
   {
     std::vector< int,std::allocator< int > > *ptr = (std::vector< int,std::allocator< int > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vinteger2d_t_insert" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vinteger2d_T_insert" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_t_insert" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_T_insert" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -15405,7 +15405,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::iterator arg2 ;
@@ -15423,33 +15423,33 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_insert__SWIG_1(PyObject *self, Py_ssize_
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_insert" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_insert" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t_insert" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T_insert" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t_insert" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T_insert" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_size_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vinteger2d_t_insert" "', argument " "3"" of type '" "std::vector< std::vector< int > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vinteger2d_T_insert" "', argument " "3"" of type '" "std::vector< std::vector< int > >::size_type""'");
   } 
   arg3 = static_cast< std::vector< std::vector< int > >::size_type >(val3);
   {
     std::vector< int,std::allocator< int > > *ptr = (std::vector< int,std::allocator< int > > *)0;
     res4 = swig::asptr(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vinteger2d_t_insert" "', argument " "4"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vinteger2d_T_insert" "', argument " "4"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_t_insert" "', argument " "4"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_T_insert" "', argument " "4"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     arg4 = ptr;
   }
@@ -15463,13 +15463,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_insert(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_insert(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_t_insert", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_T_insert", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -15483,7 +15483,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_insert(PyObject *self, PyObject *args) {
         int res = swig::asptr(argv[2], (std::vector< int,std::allocator< int > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vinteger2d_t_insert__SWIG_0(self, argc, argv);
+          return _wrap_vinteger2d_T_insert__SWIG_0(self, argc, argv);
         }
       }
     }
@@ -15505,7 +15505,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_insert(PyObject *self, PyObject *args) {
           int res = swig::asptr(argv[3], (std::vector< int,std::allocator< int > >**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vinteger2d_t_insert__SWIG_1(self, argc, argv);
+            return _wrap_vinteger2d_T_insert__SWIG_1(self, argc, argv);
           }
         }
       }
@@ -15513,7 +15513,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_insert(PyObject *self, PyObject *args) {
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_t_insert'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_T_insert'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< int > >::insert(std::vector< std::vector< int > >::iterator,std::vector< std::vector< int > >::value_type const &)\n"
     "    std::vector< std::vector< int > >::insert(std::vector< std::vector< int > >::iterator,std::vector< std::vector< int > >::size_type,std::vector< std::vector< int > >::value_type const &)\n");
@@ -15521,7 +15521,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_reserve(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_reserve(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::size_type arg2 ;
@@ -15532,15 +15532,15 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_reserve(PyObject *self, PyObject *args)
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_t_reserve", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_T_reserve", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_reserve" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_reserve" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_t_reserve" "', argument " "2"" of type '" "std::vector< std::vector< int > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_T_reserve" "', argument " "2"" of type '" "std::vector< std::vector< int > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< int > >::size_type >(val2);
   (arg1)->reserve(arg2);
@@ -15551,7 +15551,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_capacity(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_capacity(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -15564,7 +15564,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_capacity(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_capacity" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_capacity" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = ((std::vector< std::vector< int > > const *)arg1)->capacity();
@@ -15575,7 +15575,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_delete_vinteger2d_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_delete_vinteger2d_T(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -15587,7 +15587,7 @@ SWIGINTERN PyObject *_wrap_delete_vinteger2d_t(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, SWIG_POINTER_DISOWN |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vinteger2d_t" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vinteger2d_T" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   {
@@ -15608,18 +15608,18 @@ fail:
 }
 
 
-SWIGINTERN PyObject *vinteger2d_t_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vinteger2d_T_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   PyObject *obj;
   if (!SWIG_Python_UnpackTuple(args, "swigregister", 1, 1, &obj)) return NULL;
   SWIG_TypeNewClientData(SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, SWIG_NewClientData(obj));
   return SWIG_Py_Void();
 }
 
-SWIGINTERN PyObject *vinteger2d_t_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vinteger2d_T_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   return SWIG_Python_InitShadowInstance(args);
 }
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_iterator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_iterator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   PyObject **arg2 = (PyObject **) 0 ;
@@ -15634,7 +15634,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_iterator(PyObject *self, PyObjec
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_iterator" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_iterator" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = (swig::SwigPyIterator *)std_vector_Sl_unsigned_SS_long_Sg__iterator(arg1,arg2);
@@ -15645,7 +15645,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___nonzero__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___nonzero__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -15658,7 +15658,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___nonzero__(PyObject *self, PyOb
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___nonzero__" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___nonzero__" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = (bool)std_vector_Sl_unsigned_SS_long_Sg____nonzero__((std::vector< unsigned long > const *)arg1);
@@ -15669,7 +15669,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___bool__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___bool__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -15682,7 +15682,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___bool__(PyObject *self, PyObjec
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___bool__" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___bool__" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = (bool)std_vector_Sl_unsigned_SS_long_Sg____bool__((std::vector< unsigned long > const *)arg1);
@@ -15693,7 +15693,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___len__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___len__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -15706,7 +15706,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___len__(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___len__" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___len__" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = std_vector_Sl_unsigned_SS_long_Sg____len__((std::vector< unsigned long > const *)arg1);
@@ -15717,7 +15717,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___getslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___getslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::difference_type arg2 ;
@@ -15732,20 +15732,20 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___getslice__(PyObject *self, PyO
   std::vector< unsigned long,std::allocator< unsigned long > > *result = 0 ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_t___getslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_T___getslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___getslice__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___getslice__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t___getslice__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T___getslice__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< unsigned long >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_t___getslice__" "', argument " "3"" of type '" "std::vector< unsigned long >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_T___getslice__" "', argument " "3"" of type '" "std::vector< unsigned long >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< unsigned long >::difference_type >(val3);
   try {
@@ -15762,7 +15762,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::difference_type arg2 ;
@@ -15778,17 +15778,17 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setslice____SWIG_0(PyObject *s
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___setslice__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___setslice__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t___setslice__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T___setslice__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< unsigned long >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_t___setslice__" "', argument " "3"" of type '" "std::vector< unsigned long >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_T___setslice__" "', argument " "3"" of type '" "std::vector< unsigned long >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< unsigned long >::difference_type >(val3);
   try {
@@ -15805,7 +15805,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::difference_type arg2 ;
@@ -15823,27 +15823,27 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setslice____SWIG_1(PyObject *s
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___setslice__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___setslice__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t___setslice__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T___setslice__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< unsigned long >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_t___setslice__" "', argument " "3"" of type '" "std::vector< unsigned long >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_T___setslice__" "', argument " "3"" of type '" "std::vector< unsigned long >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< unsigned long >::difference_type >(val3);
   {
     std::vector< unsigned long,std::allocator< unsigned long > > *ptr = (std::vector< unsigned long,std::allocator< unsigned long > > *)0;
     res4 = swig::asptr(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_longinteger_t___setslice__" "', argument " "4"" of type '" "std::vector< unsigned long,std::allocator< unsigned long > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_longinteger_T___setslice__" "', argument " "4"" of type '" "std::vector< unsigned long,std::allocator< unsigned long > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_longinteger_t___setslice__" "', argument " "4"" of type '" "std::vector< unsigned long,std::allocator< unsigned long > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_longinteger_T___setslice__" "', argument " "4"" of type '" "std::vector< unsigned long,std::allocator< unsigned long > > const &""'"); 
     }
     arg4 = ptr;
   }
@@ -15863,13 +15863,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___setslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___setslice__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_t___setslice__", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_T___setslice__", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -15886,7 +15886,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setslice__(PyObject *self, PyO
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_longinteger_t___setslice____SWIG_0(self, argc, argv);
+          return _wrap_vector_longinteger_T___setslice____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -15909,7 +15909,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setslice__(PyObject *self, PyO
           int res = swig::asptr(argv[3], (std::vector< unsigned long,std::allocator< unsigned long > >**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vector_longinteger_t___setslice____SWIG_1(self, argc, argv);
+            return _wrap_vector_longinteger_T___setslice____SWIG_1(self, argc, argv);
           }
         }
       }
@@ -15917,7 +15917,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setslice__(PyObject *self, PyO
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_t___setslice__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_T___setslice__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< unsigned long >::__setslice__(std::vector< unsigned long >::difference_type,std::vector< unsigned long >::difference_type)\n"
     "    std::vector< unsigned long >::__setslice__(std::vector< unsigned long >::difference_type,std::vector< unsigned long >::difference_type,std::vector< unsigned long,std::allocator< unsigned long > > const &)\n");
@@ -15925,7 +15925,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___delslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___delslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::difference_type arg2 ;
@@ -15939,20 +15939,20 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___delslice__(PyObject *self, PyO
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_t___delslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_T___delslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___delslice__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___delslice__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t___delslice__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T___delslice__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< unsigned long >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_t___delslice__" "', argument " "3"" of type '" "std::vector< unsigned long >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_T___delslice__" "', argument " "3"" of type '" "std::vector< unsigned long >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< unsigned long >::difference_type >(val3);
   try {
@@ -15969,7 +15969,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::difference_type arg2 ;
@@ -15982,12 +15982,12 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___delitem____SWIG_0(PyObject *se
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___delitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___delitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t___delitem__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T___delitem__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< unsigned long >::difference_type >(val2);
   try {
@@ -16004,7 +16004,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -16016,12 +16016,12 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___getitem____SWIG_0(PyObject *se
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___getitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___getitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -16039,7 +16039,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -16052,12 +16052,12 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setitem____SWIG_0(PyObject *se
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___setitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___setitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -16065,10 +16065,10 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setitem____SWIG_0(PyObject *se
     std::vector< unsigned long,std::allocator< unsigned long > > *ptr = (std::vector< unsigned long,std::allocator< unsigned long > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_longinteger_t___setitem__" "', argument " "3"" of type '" "std::vector< unsigned long,std::allocator< unsigned long > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_longinteger_T___setitem__" "', argument " "3"" of type '" "std::vector< unsigned long,std::allocator< unsigned long > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_longinteger_t___setitem__" "', argument " "3"" of type '" "std::vector< unsigned long,std::allocator< unsigned long > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_longinteger_T___setitem__" "', argument " "3"" of type '" "std::vector< unsigned long,std::allocator< unsigned long > > const &""'"); 
     }
     arg3 = ptr;
   }
@@ -16088,7 +16088,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -16099,12 +16099,12 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setitem____SWIG_1(PyObject *se
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___setitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___setitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -16122,7 +16122,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -16133,12 +16133,12 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___delitem____SWIG_1(PyObject *se
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___delitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___delitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -16156,13 +16156,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___delitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___delitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_t___delitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_T___delitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -16173,7 +16173,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___delitem__(PyObject *self, PyOb
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_longinteger_t___delitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_longinteger_T___delitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -16187,13 +16187,13 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___delitem__(PyObject *self, PyOb
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_longinteger_t___delitem____SWIG_0(self, argc, argv);
+        return _wrap_vector_longinteger_T___delitem____SWIG_0(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_t___delitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_T___delitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< unsigned long >::__delitem__(std::vector< unsigned long >::difference_type)\n"
     "    std::vector< unsigned long >::__delitem__(SWIGPY_SLICEOBJECT *)\n");
@@ -16201,7 +16201,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::difference_type arg2 ;
@@ -16215,12 +16215,12 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___getitem____SWIG_1(PyObject *se
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___getitem__" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___getitem__" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t___getitem__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T___getitem__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< unsigned long >::difference_type >(val2);
   try {
@@ -16236,13 +16236,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___getitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___getitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_t___getitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_T___getitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -16253,7 +16253,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___getitem__(PyObject *self, PyOb
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_longinteger_t___getitem____SWIG_0(self, argc, argv);
+        return _wrap_vector_longinteger_T___getitem____SWIG_0(self, argc, argv);
       }
     }
   }
@@ -16267,13 +16267,13 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___getitem__(PyObject *self, PyOb
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_longinteger_t___getitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_longinteger_T___getitem____SWIG_1(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_t___getitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_T___getitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< unsigned long >::__getitem__(SWIGPY_SLICEOBJECT *)\n"
     "    std::vector< unsigned long >::__getitem__(std::vector< unsigned long >::difference_type) const\n");
@@ -16281,7 +16281,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::difference_type arg2 ;
@@ -16298,17 +16298,17 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setitem____SWIG_2(PyObject *se
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___setitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___setitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t___setitem__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T___setitem__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< unsigned long >::difference_type >(val2);
   ecode3 = SWIG_AsVal_unsigned_SS_long(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_t___setitem__" "', argument " "3"" of type '" "std::vector< unsigned long >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_T___setitem__" "', argument " "3"" of type '" "std::vector< unsigned long >::value_type""'");
   } 
   temp3 = static_cast< std::vector< unsigned long >::value_type >(val3);
   arg3 = &temp3;
@@ -16324,13 +16324,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___setitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___setitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_t___setitem__", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_T___setitem__", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -16341,7 +16341,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setitem__(PyObject *self, PyOb
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_longinteger_t___setitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_longinteger_T___setitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -16357,7 +16357,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setitem__(PyObject *self, PyOb
         int res = swig::asptr(argv[2], (std::vector< unsigned long,std::allocator< unsigned long > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vector_longinteger_t___setitem____SWIG_0(self, argc, argv);
+          return _wrap_vector_longinteger_T___setitem____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -16377,14 +16377,14 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setitem__(PyObject *self, PyOb
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_longinteger_t___setitem____SWIG_2(self, argc, argv);
+          return _wrap_vector_longinteger_T___setitem____SWIG_2(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_t___setitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_T___setitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< unsigned long >::__setitem__(SWIGPY_SLICEOBJECT *,std::vector< unsigned long,std::allocator< unsigned long > > const &)\n"
     "    std::vector< unsigned long >::__setitem__(SWIGPY_SLICEOBJECT *)\n"
@@ -16393,7 +16393,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_pop(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_pop(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -16406,7 +16406,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_pop(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_pop" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_pop" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   try {
@@ -16421,7 +16421,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_append(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_append(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::value_type *arg2 = 0 ;
@@ -16433,15 +16433,15 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_append(PyObject *self, PyObject
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_t_append", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_T_append", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_append" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_append" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_unsigned_SS_long(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t_append" "', argument " "2"" of type '" "std::vector< unsigned long >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T_append" "', argument " "2"" of type '" "std::vector< unsigned long >::value_type""'");
   } 
   temp2 = static_cast< std::vector< unsigned long >::value_type >(val2);
   arg2 = &temp2;
@@ -16453,7 +16453,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_longinteger_t__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
+SWIGINTERN PyObject *_wrap_new_vector_longinteger_T__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *result = 0 ;
   
@@ -16467,7 +16467,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_longinteger_t__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_longinteger_T__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = 0 ;
   int res1 = SWIG_OLDOBJ ;
@@ -16479,10 +16479,10 @@ SWIGINTERN PyObject *_wrap_new_vector_longinteger_t__SWIG_1(PyObject *self, Py_s
     std::vector< unsigned long,std::allocator< unsigned long > > *ptr = (std::vector< unsigned long,std::allocator< unsigned long > > *)0;
     res1 = swig::asptr(swig_obj[0], &ptr);
     if (!SWIG_IsOK(res1)) {
-      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vector_longinteger_t" "', argument " "1"" of type '" "std::vector< unsigned long > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vector_longinteger_T" "', argument " "1"" of type '" "std::vector< unsigned long > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_longinteger_t" "', argument " "1"" of type '" "std::vector< unsigned long > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_longinteger_T" "', argument " "1"" of type '" "std::vector< unsigned long > const &""'"); 
     }
     arg1 = ptr;
   }
@@ -16496,7 +16496,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_empty(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_empty(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -16509,7 +16509,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_empty(PyObject *self, PyObject *
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_empty" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_empty" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = (bool)((std::vector< unsigned long > const *)arg1)->empty();
@@ -16520,7 +16520,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_size(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_size(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -16533,7 +16533,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_size(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_size" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_size" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = ((std::vector< unsigned long > const *)arg1)->size();
@@ -16544,7 +16544,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_swap(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_swap(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long > *arg2 = 0 ;
@@ -16555,18 +16555,18 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_swap(PyObject *self, PyObject *a
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_t_swap", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_T_swap", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_swap" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_swap" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], &argp2, SWIGTYPE_p_std__vectorT_unsigned_long_t,  0 );
   if (!SWIG_IsOK(res2)) {
-    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_longinteger_t_swap" "', argument " "2"" of type '" "std::vector< unsigned long > &""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_longinteger_T_swap" "', argument " "2"" of type '" "std::vector< unsigned long > &""'"); 
   }
   if (!argp2) {
-    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_longinteger_t_swap" "', argument " "2"" of type '" "std::vector< unsigned long > &""'"); 
+    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_longinteger_T_swap" "', argument " "2"" of type '" "std::vector< unsigned long > &""'"); 
   }
   arg2 = reinterpret_cast< std::vector< unsigned long > * >(argp2);
   (arg1)->swap(*arg2);
@@ -16577,7 +16577,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_begin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_begin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -16590,7 +16590,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_begin(PyObject *self, PyObject *
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_begin" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_begin" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = (arg1)->begin();
@@ -16602,7 +16602,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_end(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_end(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -16615,7 +16615,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_end(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_end" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_end" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = (arg1)->end();
@@ -16627,7 +16627,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_rbegin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_rbegin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -16640,7 +16640,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_rbegin(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_rbegin" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_rbegin" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = (arg1)->rbegin();
@@ -16652,7 +16652,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_rend(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_rend(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -16665,7 +16665,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_rend(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_rend" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_rend" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = (arg1)->rend();
@@ -16677,7 +16677,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_clear(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_clear(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -16689,7 +16689,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_clear(PyObject *self, PyObject *
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_clear" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_clear" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   (arg1)->clear();
@@ -16700,7 +16700,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_get_allocator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_get_allocator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -16713,7 +16713,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_get_allocator(PyObject *self, Py
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_get_allocator" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_get_allocator" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = ((std::vector< unsigned long > const *)arg1)->get_allocator();
@@ -16724,7 +16724,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_longinteger_t__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_longinteger_T__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long >::size_type arg1 ;
   size_t val1 ;
@@ -16735,7 +16735,7 @@ SWIGINTERN PyObject *_wrap_new_vector_longinteger_t__SWIG_2(PyObject *self, Py_s
   if ((nobjs < 1) || (nobjs > 1)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_longinteger_t" "', argument " "1"" of type '" "std::vector< unsigned long >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_longinteger_T" "', argument " "1"" of type '" "std::vector< unsigned long >::size_type""'");
   } 
   arg1 = static_cast< std::vector< unsigned long >::size_type >(val1);
   result = (std::vector< unsigned long > *)new std::vector< unsigned long >(arg1);
@@ -16746,7 +16746,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_pop_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_pop_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -16758,7 +16758,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_pop_back(PyObject *self, PyObjec
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_pop_back" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_pop_back" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   (arg1)->pop_back();
@@ -16769,7 +16769,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::size_type arg2 ;
@@ -16782,12 +16782,12 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_resize__SWIG_0(PyObject *self, P
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_resize" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_resize" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t_resize" "', argument " "2"" of type '" "std::vector< unsigned long >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T_resize" "', argument " "2"" of type '" "std::vector< unsigned long >::size_type""'");
   } 
   arg2 = static_cast< std::vector< unsigned long >::size_type >(val2);
   (arg1)->resize(arg2);
@@ -16798,7 +16798,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::iterator arg2 ;
@@ -16812,18 +16812,18 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_erase__SWIG_0(PyObject *self, Py
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_erase" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_erase" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t_erase" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T_erase" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t_erase" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T_erase" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
     }
   }
   result = std_vector_Sl_unsigned_SS_long_Sg__erase__SWIG_0(arg1,SWIG_STD_MOVE(arg2));
@@ -16835,7 +16835,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::iterator arg2 ;
@@ -16852,29 +16852,29 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_erase__SWIG_1(PyObject *self, Py
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_erase" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_erase" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t_erase" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T_erase" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t_erase" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T_erase" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
     }
   }
   res3 = SWIG_ConvertPtr(swig_obj[2], SWIG_as_voidptrptr(&iter3), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res3) || !iter3) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t_erase" "', argument " "3"" of type '" "std::vector< unsigned long >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T_erase" "', argument " "3"" of type '" "std::vector< unsigned long >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *>(iter3);
     if (iter_t) {
       arg3 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t_erase" "', argument " "3"" of type '" "std::vector< unsigned long >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T_erase" "', argument " "3"" of type '" "std::vector< unsigned long >::iterator""'");
     }
   }
   result = std_vector_Sl_unsigned_SS_long_Sg__erase__SWIG_1(arg1,SWIG_STD_MOVE(arg2),SWIG_STD_MOVE(arg3));
@@ -16886,13 +16886,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_erase(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_erase(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_t_erase", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_T_erase", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -16903,7 +16903,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_erase(PyObject *self, PyObject *
       int res = SWIG_ConvertPtr(argv[1], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
       _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *>(iter) != 0));
       if (_v) {
-        return _wrap_vector_longinteger_t_erase__SWIG_0(self, argc, argv);
+        return _wrap_vector_longinteger_T_erase__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -16920,14 +16920,14 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_erase(PyObject *self, PyObject *
         int res = SWIG_ConvertPtr(argv[2], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
         _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *>(iter) != 0));
         if (_v) {
-          return _wrap_vector_longinteger_t_erase__SWIG_1(self, argc, argv);
+          return _wrap_vector_longinteger_T_erase__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_t_erase'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_T_erase'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< unsigned long >::erase(std::vector< unsigned long >::iterator)\n"
     "    std::vector< unsigned long >::erase(std::vector< unsigned long >::iterator,std::vector< unsigned long >::iterator)\n");
@@ -16935,7 +16935,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_longinteger_t__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_longinteger_T__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long >::size_type arg1 ;
   std::vector< unsigned long >::value_type *arg2 = 0 ;
@@ -16950,12 +16950,12 @@ SWIGINTERN PyObject *_wrap_new_vector_longinteger_t__SWIG_3(PyObject *self, Py_s
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_longinteger_t" "', argument " "1"" of type '" "std::vector< unsigned long >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_longinteger_T" "', argument " "1"" of type '" "std::vector< unsigned long >::size_type""'");
   } 
   arg1 = static_cast< std::vector< unsigned long >::size_type >(val1);
   ecode2 = SWIG_AsVal_unsigned_SS_long(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "new_vector_longinteger_t" "', argument " "2"" of type '" "std::vector< unsigned long >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "new_vector_longinteger_T" "', argument " "2"" of type '" "std::vector< unsigned long >::value_type""'");
   } 
   temp2 = static_cast< std::vector< unsigned long >::value_type >(val2);
   arg2 = &temp2;
@@ -16967,16 +16967,16 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_longinteger_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_new_vector_longinteger_T(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vector_longinteger_t", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vector_longinteger_T", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 0) {
-    return _wrap_new_vector_longinteger_t__SWIG_0(self, argc, argv);
+    return _wrap_new_vector_longinteger_T__SWIG_0(self, argc, argv);
   }
   if (argc == 1) {
     int _v = 0;
@@ -16985,7 +16985,7 @@ SWIGINTERN PyObject *_wrap_new_vector_longinteger_t(PyObject *self, PyObject *ar
       _v = SWIG_CheckState(res);
     }
     if (_v) {
-      return _wrap_new_vector_longinteger_t__SWIG_2(self, argc, argv);
+      return _wrap_new_vector_longinteger_T__SWIG_2(self, argc, argv);
     }
   }
   if (argc == 1) {
@@ -16993,7 +16993,7 @@ SWIGINTERN PyObject *_wrap_new_vector_longinteger_t(PyObject *self, PyObject *ar
     int res = swig::asptr(argv[0], (std::vector< unsigned long,std::allocator< unsigned long > >**)(0));
     _v = SWIG_CheckState(res);
     if (_v) {
-      return _wrap_new_vector_longinteger_t__SWIG_1(self, argc, argv);
+      return _wrap_new_vector_longinteger_T__SWIG_1(self, argc, argv);
     }
   }
   if (argc == 2) {
@@ -17008,13 +17008,13 @@ SWIGINTERN PyObject *_wrap_new_vector_longinteger_t(PyObject *self, PyObject *ar
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_new_vector_longinteger_t__SWIG_3(self, argc, argv);
+        return _wrap_new_vector_longinteger_T__SWIG_3(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vector_longinteger_t'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vector_longinteger_T'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< unsigned long >::vector()\n"
     "    std::vector< unsigned long >::vector(std::vector< unsigned long > const &)\n"
@@ -17024,7 +17024,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_push_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_push_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::value_type *arg2 = 0 ;
@@ -17036,15 +17036,15 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_push_back(PyObject *self, PyObje
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_t_push_back", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_T_push_back", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_push_back" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_push_back" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_unsigned_SS_long(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t_push_back" "', argument " "2"" of type '" "std::vector< unsigned long >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T_push_back" "', argument " "2"" of type '" "std::vector< unsigned long >::value_type""'");
   } 
   temp2 = static_cast< std::vector< unsigned long >::value_type >(val2);
   arg2 = &temp2;
@@ -17056,7 +17056,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_front(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_front(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -17069,7 +17069,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_front(PyObject *self, PyObject *
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_front" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_front" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = (std::vector< unsigned long >::value_type *) &((std::vector< unsigned long > const *)arg1)->front();
@@ -17081,7 +17081,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -17094,7 +17094,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_back(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_back" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_back" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = (std::vector< unsigned long >::value_type *) &((std::vector< unsigned long > const *)arg1)->back();
@@ -17106,7 +17106,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_assign(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_assign(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::size_type arg2 ;
@@ -17121,20 +17121,20 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_assign(PyObject *self, PyObject
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_t_assign", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_T_assign", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_assign" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_assign" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t_assign" "', argument " "2"" of type '" "std::vector< unsigned long >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T_assign" "', argument " "2"" of type '" "std::vector< unsigned long >::size_type""'");
   } 
   arg2 = static_cast< std::vector< unsigned long >::size_type >(val2);
   ecode3 = SWIG_AsVal_unsigned_SS_long(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_t_assign" "', argument " "3"" of type '" "std::vector< unsigned long >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_T_assign" "', argument " "3"" of type '" "std::vector< unsigned long >::value_type""'");
   } 
   temp3 = static_cast< std::vector< unsigned long >::value_type >(val3);
   arg3 = &temp3;
@@ -17146,7 +17146,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::size_type arg2 ;
@@ -17163,17 +17163,17 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_resize__SWIG_1(PyObject *self, P
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_resize" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_resize" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t_resize" "', argument " "2"" of type '" "std::vector< unsigned long >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T_resize" "', argument " "2"" of type '" "std::vector< unsigned long >::size_type""'");
   } 
   arg2 = static_cast< std::vector< unsigned long >::size_type >(val2);
   ecode3 = SWIG_AsVal_unsigned_SS_long(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_t_resize" "', argument " "3"" of type '" "std::vector< unsigned long >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_T_resize" "', argument " "3"" of type '" "std::vector< unsigned long >::value_type""'");
   } 
   temp3 = static_cast< std::vector< unsigned long >::value_type >(val3);
   arg3 = &temp3;
@@ -17185,13 +17185,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_resize(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_resize(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_t_resize", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_T_resize", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -17203,7 +17203,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_resize(PyObject *self, PyObject
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_longinteger_t_resize__SWIG_0(self, argc, argv);
+        return _wrap_vector_longinteger_T_resize__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -17222,14 +17222,14 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_resize(PyObject *self, PyObject
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_longinteger_t_resize__SWIG_1(self, argc, argv);
+          return _wrap_vector_longinteger_T_resize__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_t_resize'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_T_resize'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< unsigned long >::resize(std::vector< unsigned long >::size_type)\n"
     "    std::vector< unsigned long >::resize(std::vector< unsigned long >::size_type,std::vector< unsigned long >::value_type const &)\n");
@@ -17237,7 +17237,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::iterator arg2 ;
@@ -17255,23 +17255,23 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_insert__SWIG_0(PyObject *self, P
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_insert" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_insert" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t_insert" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T_insert" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t_insert" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T_insert" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_unsigned_SS_long(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_t_insert" "', argument " "3"" of type '" "std::vector< unsigned long >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_T_insert" "', argument " "3"" of type '" "std::vector< unsigned long >::value_type""'");
   } 
   temp3 = static_cast< std::vector< unsigned long >::value_type >(val3);
   arg3 = &temp3;
@@ -17284,7 +17284,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::iterator arg2 ;
@@ -17304,28 +17304,28 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_insert__SWIG_1(PyObject *self, P
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_insert" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_insert" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t_insert" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T_insert" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t_insert" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T_insert" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_size_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_t_insert" "', argument " "3"" of type '" "std::vector< unsigned long >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_T_insert" "', argument " "3"" of type '" "std::vector< unsigned long >::size_type""'");
   } 
   arg3 = static_cast< std::vector< unsigned long >::size_type >(val3);
   ecode4 = SWIG_AsVal_unsigned_SS_long(swig_obj[3], &val4);
   if (!SWIG_IsOK(ecode4)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode4), "in method '" "vector_longinteger_t_insert" "', argument " "4"" of type '" "std::vector< unsigned long >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode4), "in method '" "vector_longinteger_T_insert" "', argument " "4"" of type '" "std::vector< unsigned long >::value_type""'");
   } 
   temp4 = static_cast< std::vector< unsigned long >::value_type >(val4);
   arg4 = &temp4;
@@ -17337,13 +17337,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_insert(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_insert(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_t_insert", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_T_insert", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -17359,7 +17359,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_insert(PyObject *self, PyObject
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_longinteger_t_insert__SWIG_0(self, argc, argv);
+          return _wrap_vector_longinteger_T_insert__SWIG_0(self, argc, argv);
         }
       }
     }
@@ -17383,7 +17383,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_insert(PyObject *self, PyObject
             _v = SWIG_CheckState(res);
           }
           if (_v) {
-            return _wrap_vector_longinteger_t_insert__SWIG_1(self, argc, argv);
+            return _wrap_vector_longinteger_T_insert__SWIG_1(self, argc, argv);
           }
         }
       }
@@ -17391,7 +17391,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_insert(PyObject *self, PyObject
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_t_insert'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_T_insert'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< unsigned long >::insert(std::vector< unsigned long >::iterator,std::vector< unsigned long >::value_type const &)\n"
     "    std::vector< unsigned long >::insert(std::vector< unsigned long >::iterator,std::vector< unsigned long >::size_type,std::vector< unsigned long >::value_type const &)\n");
@@ -17399,7 +17399,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_reserve(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_reserve(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::size_type arg2 ;
@@ -17410,15 +17410,15 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_reserve(PyObject *self, PyObject
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_t_reserve", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_T_reserve", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_reserve" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_reserve" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t_reserve" "', argument " "2"" of type '" "std::vector< unsigned long >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T_reserve" "', argument " "2"" of type '" "std::vector< unsigned long >::size_type""'");
   } 
   arg2 = static_cast< std::vector< unsigned long >::size_type >(val2);
   (arg1)->reserve(arg2);
@@ -17429,7 +17429,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_capacity(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_capacity(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -17442,7 +17442,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_capacity(PyObject *self, PyObjec
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_capacity" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_capacity" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = ((std::vector< unsigned long > const *)arg1)->capacity();
@@ -17453,7 +17453,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_delete_vector_longinteger_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_delete_vector_longinteger_T(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -17465,7 +17465,7 @@ SWIGINTERN PyObject *_wrap_delete_vector_longinteger_t(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, SWIG_POINTER_DISOWN |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vector_longinteger_t" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vector_longinteger_T" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   {
@@ -17486,18 +17486,18 @@ fail:
 }
 
 
-SWIGINTERN PyObject *vector_longinteger_t_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vector_longinteger_T_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   PyObject *obj;
   if (!SWIG_Python_UnpackTuple(args, "swigregister", 1, 1, &obj)) return NULL;
   SWIG_TypeNewClientData(SWIGTYPE_p_std__vectorT_unsigned_long_t, SWIG_NewClientData(obj));
   return SWIG_Py_Void();
 }
 
-SWIGINTERN PyObject *vector_longinteger_t_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vector_longinteger_T_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   return SWIG_Python_InitShadowInstance(args);
 }
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_iterator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_iterator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   PyObject **arg2 = (PyObject **) 0 ;
@@ -17512,7 +17512,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_iterator(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_iterator" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_iterator" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = (swig::SwigPyIterator *)std_vector_Sl_std_complex_Sl_double_Sg__Sg__iterator(arg1,arg2);
@@ -17523,7 +17523,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___nonzero__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___nonzero__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -17536,7 +17536,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___nonzero__(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___nonzero__" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___nonzero__" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = (bool)std_vector_Sl_std_complex_Sl_double_Sg__Sg____nonzero__((std::vector< std::complex< double > > const *)arg1);
@@ -17547,7 +17547,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___bool__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___bool__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -17560,7 +17560,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___bool__(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___bool__" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___bool__" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = (bool)std_vector_Sl_std_complex_Sl_double_Sg__Sg____bool__((std::vector< std::complex< double > > const *)arg1);
@@ -17571,7 +17571,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___len__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___len__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -17584,7 +17584,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___len__(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___len__" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___len__" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = std_vector_Sl_std_complex_Sl_double_Sg__Sg____len__((std::vector< std::complex< double > > const *)arg1);
@@ -17595,7 +17595,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___getslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___getslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::difference_type arg2 ;
@@ -17610,20 +17610,20 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___getslice__(PyObject *self, PyObjec
   std::vector< std::complex< double >,std::allocator< std::complex< double > > > *result = 0 ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_complex_t___getslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_complex_T___getslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___getslice__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___getslice__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t___getslice__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T___getslice__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::complex< double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_t___getslice__" "', argument " "3"" of type '" "std::vector< std::complex< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_T___getslice__" "', argument " "3"" of type '" "std::vector< std::complex< double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::complex< double > >::difference_type >(val3);
   try {
@@ -17640,7 +17640,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::difference_type arg2 ;
@@ -17656,17 +17656,17 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setslice____SWIG_0(PyObject *self,
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___setslice__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___setslice__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t___setslice__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T___setslice__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::complex< double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_t___setslice__" "', argument " "3"" of type '" "std::vector< std::complex< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_T___setslice__" "', argument " "3"" of type '" "std::vector< std::complex< double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::complex< double > >::difference_type >(val3);
   try {
@@ -17683,7 +17683,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::difference_type arg2 ;
@@ -17701,27 +17701,27 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setslice____SWIG_1(PyObject *self,
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___setslice__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___setslice__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t___setslice__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T___setslice__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::complex< double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_t___setslice__" "', argument " "3"" of type '" "std::vector< std::complex< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_T___setslice__" "', argument " "3"" of type '" "std::vector< std::complex< double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::complex< double > >::difference_type >(val3);
   {
     std::vector< std::complex< double >,std::allocator< std::complex< double > > > *ptr = (std::vector< std::complex< double >,std::allocator< std::complex< double > > > *)0;
     res4 = swig::asptr(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_complex_t___setslice__" "', argument " "4"" of type '" "std::vector< std::complex< double >,std::allocator< std::complex< double > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_complex_T___setslice__" "', argument " "4"" of type '" "std::vector< std::complex< double >,std::allocator< std::complex< double > > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_complex_t___setslice__" "', argument " "4"" of type '" "std::vector< std::complex< double >,std::allocator< std::complex< double > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_complex_T___setslice__" "', argument " "4"" of type '" "std::vector< std::complex< double >,std::allocator< std::complex< double > > > const &""'"); 
     }
     arg4 = ptr;
   }
@@ -17741,13 +17741,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___setslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___setslice__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_t___setslice__", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_T___setslice__", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -17764,7 +17764,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setslice__(PyObject *self, PyObjec
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_complex_t___setslice____SWIG_0(self, argc, argv);
+          return _wrap_vector_complex_T___setslice____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -17787,7 +17787,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setslice__(PyObject *self, PyObjec
           int res = swig::asptr(argv[3], (std::vector< std::complex< double >,std::allocator< std::complex< double > > >**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vector_complex_t___setslice____SWIG_1(self, argc, argv);
+            return _wrap_vector_complex_T___setslice____SWIG_1(self, argc, argv);
           }
         }
       }
@@ -17795,7 +17795,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setslice__(PyObject *self, PyObjec
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_t___setslice__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_T___setslice__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::complex< double > >::__setslice__(std::vector< std::complex< double > >::difference_type,std::vector< std::complex< double > >::difference_type)\n"
     "    std::vector< std::complex< double > >::__setslice__(std::vector< std::complex< double > >::difference_type,std::vector< std::complex< double > >::difference_type,std::vector< std::complex< double >,std::allocator< std::complex< double > > > const &)\n");
@@ -17803,7 +17803,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___delslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___delslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::difference_type arg2 ;
@@ -17817,20 +17817,20 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___delslice__(PyObject *self, PyObjec
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_complex_t___delslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_complex_T___delslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___delslice__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___delslice__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t___delslice__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T___delslice__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::complex< double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_t___delslice__" "', argument " "3"" of type '" "std::vector< std::complex< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_T___delslice__" "', argument " "3"" of type '" "std::vector< std::complex< double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::complex< double > >::difference_type >(val3);
   try {
@@ -17847,7 +17847,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::difference_type arg2 ;
@@ -17860,12 +17860,12 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___delitem____SWIG_0(PyObject *self,
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___delitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___delitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t___delitem__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T___delitem__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::complex< double > >::difference_type >(val2);
   try {
@@ -17882,7 +17882,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -17894,12 +17894,12 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___getitem____SWIG_0(PyObject *self,
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___getitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___getitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -17917,7 +17917,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -17930,12 +17930,12 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setitem____SWIG_0(PyObject *self,
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___setitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___setitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -17943,10 +17943,10 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setitem____SWIG_0(PyObject *self,
     std::vector< std::complex< double >,std::allocator< std::complex< double > > > *ptr = (std::vector< std::complex< double >,std::allocator< std::complex< double > > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_complex_t___setitem__" "', argument " "3"" of type '" "std::vector< std::complex< double >,std::allocator< std::complex< double > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_complex_T___setitem__" "', argument " "3"" of type '" "std::vector< std::complex< double >,std::allocator< std::complex< double > > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_complex_t___setitem__" "', argument " "3"" of type '" "std::vector< std::complex< double >,std::allocator< std::complex< double > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_complex_T___setitem__" "', argument " "3"" of type '" "std::vector< std::complex< double >,std::allocator< std::complex< double > > > const &""'"); 
     }
     arg3 = ptr;
   }
@@ -17966,7 +17966,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -17977,12 +17977,12 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setitem____SWIG_1(PyObject *self,
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___setitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___setitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -18000,7 +18000,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -18011,12 +18011,12 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___delitem____SWIG_1(PyObject *self,
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___delitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___delitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -18034,13 +18034,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___delitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___delitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_t___delitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_T___delitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -18051,7 +18051,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___delitem__(PyObject *self, PyObject
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_complex_t___delitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_complex_T___delitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -18065,13 +18065,13 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___delitem__(PyObject *self, PyObject
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_complex_t___delitem____SWIG_0(self, argc, argv);
+        return _wrap_vector_complex_T___delitem____SWIG_0(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_t___delitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_T___delitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::complex< double > >::__delitem__(std::vector< std::complex< double > >::difference_type)\n"
     "    std::vector< std::complex< double > >::__delitem__(SWIGPY_SLICEOBJECT *)\n");
@@ -18079,7 +18079,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::difference_type arg2 ;
@@ -18093,12 +18093,12 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___getitem____SWIG_1(PyObject *self,
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___getitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___getitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t___getitem__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T___getitem__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::complex< double > >::difference_type >(val2);
   try {
@@ -18114,13 +18114,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___getitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___getitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_t___getitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_T___getitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -18131,7 +18131,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___getitem__(PyObject *self, PyObject
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_complex_t___getitem____SWIG_0(self, argc, argv);
+        return _wrap_vector_complex_T___getitem____SWIG_0(self, argc, argv);
       }
     }
   }
@@ -18145,13 +18145,13 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___getitem__(PyObject *self, PyObject
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_complex_t___getitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_complex_T___getitem____SWIG_1(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_t___getitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_T___getitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::complex< double > >::__getitem__(SWIGPY_SLICEOBJECT *)\n"
     "    std::vector< std::complex< double > >::__getitem__(std::vector< std::complex< double > >::difference_type) const\n");
@@ -18159,7 +18159,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::difference_type arg2 ;
@@ -18176,17 +18176,17 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setitem____SWIG_2(PyObject *self,
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___setitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___setitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t___setitem__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T___setitem__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::complex< double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_std_complex_Sl_double_Sg_(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_t___setitem__" "', argument " "3"" of type '" "std::vector< std::complex< double > >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_T___setitem__" "', argument " "3"" of type '" "std::vector< std::complex< double > >::value_type""'");
   } 
   temp3 = static_cast< std::vector< std::complex< double > >::value_type >(val3);
   arg3 = &temp3;
@@ -18202,13 +18202,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___setitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___setitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_t___setitem__", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_T___setitem__", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -18219,7 +18219,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setitem__(PyObject *self, PyObject
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_complex_t___setitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_complex_T___setitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -18235,7 +18235,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setitem__(PyObject *self, PyObject
         int res = swig::asptr(argv[2], (std::vector< std::complex< double >,std::allocator< std::complex< double > > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vector_complex_t___setitem____SWIG_0(self, argc, argv);
+          return _wrap_vector_complex_T___setitem____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -18255,14 +18255,14 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setitem__(PyObject *self, PyObject
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_complex_t___setitem____SWIG_2(self, argc, argv);
+          return _wrap_vector_complex_T___setitem____SWIG_2(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_t___setitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_T___setitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::complex< double > >::__setitem__(SWIGPY_SLICEOBJECT *,std::vector< std::complex< double >,std::allocator< std::complex< double > > > const &)\n"
     "    std::vector< std::complex< double > >::__setitem__(SWIGPY_SLICEOBJECT *)\n"
@@ -18271,7 +18271,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_pop(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_pop(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -18284,7 +18284,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_pop(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_pop" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_pop" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   try {
@@ -18299,7 +18299,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_append(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_append(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::value_type *arg2 = 0 ;
@@ -18311,15 +18311,15 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_append(PyObject *self, PyObject *arg
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_complex_t_append", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_complex_T_append", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_append" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_append" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_std_complex_Sl_double_Sg_(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t_append" "', argument " "2"" of type '" "std::vector< std::complex< double > >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T_append" "', argument " "2"" of type '" "std::vector< std::complex< double > >::value_type""'");
   } 
   temp2 = static_cast< std::vector< std::complex< double > >::value_type >(val2);
   arg2 = &temp2;
@@ -18331,7 +18331,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_complex_t__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
+SWIGINTERN PyObject *_wrap_new_vector_complex_T__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *result = 0 ;
   
@@ -18345,7 +18345,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_complex_t__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_complex_T__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = 0 ;
   int res1 = SWIG_OLDOBJ ;
@@ -18357,10 +18357,10 @@ SWIGINTERN PyObject *_wrap_new_vector_complex_t__SWIG_1(PyObject *self, Py_ssize
     std::vector< std::complex< double >,std::allocator< std::complex< double > > > *ptr = (std::vector< std::complex< double >,std::allocator< std::complex< double > > > *)0;
     res1 = swig::asptr(swig_obj[0], &ptr);
     if (!SWIG_IsOK(res1)) {
-      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vector_complex_t" "', argument " "1"" of type '" "std::vector< std::complex< double > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vector_complex_T" "', argument " "1"" of type '" "std::vector< std::complex< double > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_complex_t" "', argument " "1"" of type '" "std::vector< std::complex< double > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_complex_T" "', argument " "1"" of type '" "std::vector< std::complex< double > > const &""'"); 
     }
     arg1 = ptr;
   }
@@ -18374,7 +18374,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_empty(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_empty(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -18387,7 +18387,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_empty(PyObject *self, PyObject *args
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_empty" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_empty" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = (bool)((std::vector< std::complex< double > > const *)arg1)->empty();
@@ -18398,7 +18398,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_size(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_size(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -18411,7 +18411,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_size(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_size" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_size" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = ((std::vector< std::complex< double > > const *)arg1)->size();
@@ -18422,7 +18422,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_swap(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_swap(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > > *arg2 = 0 ;
@@ -18433,18 +18433,18 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_swap(PyObject *self, PyObject *args)
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_complex_t_swap", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_complex_T_swap", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_swap" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_swap" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], &argp2, SWIGTYPE_p_std__vectorT_std__complexT_double_t_t,  0 );
   if (!SWIG_IsOK(res2)) {
-    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_complex_t_swap" "', argument " "2"" of type '" "std::vector< std::complex< double > > &""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_complex_T_swap" "', argument " "2"" of type '" "std::vector< std::complex< double > > &""'"); 
   }
   if (!argp2) {
-    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_complex_t_swap" "', argument " "2"" of type '" "std::vector< std::complex< double > > &""'"); 
+    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_complex_T_swap" "', argument " "2"" of type '" "std::vector< std::complex< double > > &""'"); 
   }
   arg2 = reinterpret_cast< std::vector< std::complex< double > > * >(argp2);
   (arg1)->swap(*arg2);
@@ -18455,7 +18455,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_begin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_begin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -18468,7 +18468,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_begin(PyObject *self, PyObject *args
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_begin" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_begin" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = (arg1)->begin();
@@ -18480,7 +18480,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_end(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_end(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -18493,7 +18493,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_end(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_end" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_end" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = (arg1)->end();
@@ -18505,7 +18505,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_rbegin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_rbegin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -18518,7 +18518,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_rbegin(PyObject *self, PyObject *arg
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_rbegin" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_rbegin" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = (arg1)->rbegin();
@@ -18530,7 +18530,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_rend(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_rend(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -18543,7 +18543,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_rend(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_rend" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_rend" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = (arg1)->rend();
@@ -18555,7 +18555,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_clear(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_clear(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -18567,7 +18567,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_clear(PyObject *self, PyObject *args
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_clear" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_clear" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   (arg1)->clear();
@@ -18578,7 +18578,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_get_allocator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_get_allocator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -18591,7 +18591,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_get_allocator(PyObject *self, PyObje
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_get_allocator" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_get_allocator" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = ((std::vector< std::complex< double > > const *)arg1)->get_allocator();
@@ -18602,7 +18602,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_complex_t__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_complex_T__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > >::size_type arg1 ;
   size_t val1 ;
@@ -18613,7 +18613,7 @@ SWIGINTERN PyObject *_wrap_new_vector_complex_t__SWIG_2(PyObject *self, Py_ssize
   if ((nobjs < 1) || (nobjs > 1)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_complex_t" "', argument " "1"" of type '" "std::vector< std::complex< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_complex_T" "', argument " "1"" of type '" "std::vector< std::complex< double > >::size_type""'");
   } 
   arg1 = static_cast< std::vector< std::complex< double > >::size_type >(val1);
   result = (std::vector< std::complex< double > > *)new std::vector< std::complex< double > >(arg1);
@@ -18624,7 +18624,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_pop_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_pop_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -18636,7 +18636,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_pop_back(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_pop_back" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_pop_back" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   (arg1)->pop_back();
@@ -18647,7 +18647,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::size_type arg2 ;
@@ -18660,12 +18660,12 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_resize__SWIG_0(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_resize" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_resize" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t_resize" "', argument " "2"" of type '" "std::vector< std::complex< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T_resize" "', argument " "2"" of type '" "std::vector< std::complex< double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::complex< double > >::size_type >(val2);
   (arg1)->resize(arg2);
@@ -18676,7 +18676,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::iterator arg2 ;
@@ -18690,18 +18690,18 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_erase__SWIG_0(PyObject *self, Py_ssi
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_erase" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_erase" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t_erase" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T_erase" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t_erase" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T_erase" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
     }
   }
   result = std_vector_Sl_std_complex_Sl_double_Sg__Sg__erase__SWIG_0(arg1,SWIG_STD_MOVE(arg2));
@@ -18713,7 +18713,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::iterator arg2 ;
@@ -18730,29 +18730,29 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_erase__SWIG_1(PyObject *self, Py_ssi
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_erase" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_erase" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t_erase" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T_erase" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t_erase" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T_erase" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
     }
   }
   res3 = SWIG_ConvertPtr(swig_obj[2], SWIG_as_voidptrptr(&iter3), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res3) || !iter3) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t_erase" "', argument " "3"" of type '" "std::vector< std::complex< double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T_erase" "', argument " "3"" of type '" "std::vector< std::complex< double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *>(iter3);
     if (iter_t) {
       arg3 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t_erase" "', argument " "3"" of type '" "std::vector< std::complex< double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T_erase" "', argument " "3"" of type '" "std::vector< std::complex< double > >::iterator""'");
     }
   }
   result = std_vector_Sl_std_complex_Sl_double_Sg__Sg__erase__SWIG_1(arg1,SWIG_STD_MOVE(arg2),SWIG_STD_MOVE(arg3));
@@ -18764,13 +18764,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_erase(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_erase(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_t_erase", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_T_erase", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -18781,7 +18781,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_erase(PyObject *self, PyObject *args
       int res = SWIG_ConvertPtr(argv[1], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
       _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *>(iter) != 0));
       if (_v) {
-        return _wrap_vector_complex_t_erase__SWIG_0(self, argc, argv);
+        return _wrap_vector_complex_T_erase__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -18798,14 +18798,14 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_erase(PyObject *self, PyObject *args
         int res = SWIG_ConvertPtr(argv[2], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
         _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *>(iter) != 0));
         if (_v) {
-          return _wrap_vector_complex_t_erase__SWIG_1(self, argc, argv);
+          return _wrap_vector_complex_T_erase__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_t_erase'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_T_erase'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::complex< double > >::erase(std::vector< std::complex< double > >::iterator)\n"
     "    std::vector< std::complex< double > >::erase(std::vector< std::complex< double > >::iterator,std::vector< std::complex< double > >::iterator)\n");
@@ -18813,7 +18813,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_complex_t__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_complex_T__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > >::size_type arg1 ;
   std::vector< std::complex< double > >::value_type *arg2 = 0 ;
@@ -18828,12 +18828,12 @@ SWIGINTERN PyObject *_wrap_new_vector_complex_t__SWIG_3(PyObject *self, Py_ssize
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_complex_t" "', argument " "1"" of type '" "std::vector< std::complex< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_complex_T" "', argument " "1"" of type '" "std::vector< std::complex< double > >::size_type""'");
   } 
   arg1 = static_cast< std::vector< std::complex< double > >::size_type >(val1);
   ecode2 = SWIG_AsVal_std_complex_Sl_double_Sg_(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "new_vector_complex_t" "', argument " "2"" of type '" "std::vector< std::complex< double > >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "new_vector_complex_T" "', argument " "2"" of type '" "std::vector< std::complex< double > >::value_type""'");
   } 
   temp2 = static_cast< std::vector< std::complex< double > >::value_type >(val2);
   arg2 = &temp2;
@@ -18845,16 +18845,16 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_complex_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_new_vector_complex_T(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vector_complex_t", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vector_complex_T", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 0) {
-    return _wrap_new_vector_complex_t__SWIG_0(self, argc, argv);
+    return _wrap_new_vector_complex_T__SWIG_0(self, argc, argv);
   }
   if (argc == 1) {
     int _v = 0;
@@ -18863,7 +18863,7 @@ SWIGINTERN PyObject *_wrap_new_vector_complex_t(PyObject *self, PyObject *args)
       _v = SWIG_CheckState(res);
     }
     if (_v) {
-      return _wrap_new_vector_complex_t__SWIG_2(self, argc, argv);
+      return _wrap_new_vector_complex_T__SWIG_2(self, argc, argv);
     }
   }
   if (argc == 1) {
@@ -18871,7 +18871,7 @@ SWIGINTERN PyObject *_wrap_new_vector_complex_t(PyObject *self, PyObject *args)
     int res = swig::asptr(argv[0], (std::vector< std::complex< double >,std::allocator< std::complex< double > > >**)(0));
     _v = SWIG_CheckState(res);
     if (_v) {
-      return _wrap_new_vector_complex_t__SWIG_1(self, argc, argv);
+      return _wrap_new_vector_complex_T__SWIG_1(self, argc, argv);
     }
   }
   if (argc == 2) {
@@ -18886,13 +18886,13 @@ SWIGINTERN PyObject *_wrap_new_vector_complex_t(PyObject *self, PyObject *args)
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_new_vector_complex_t__SWIG_3(self, argc, argv);
+        return _wrap_new_vector_complex_T__SWIG_3(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vector_complex_t'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vector_complex_T'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::complex< double > >::vector()\n"
     "    std::vector< std::complex< double > >::vector(std::vector< std::complex< double > > const &)\n"
@@ -18902,7 +18902,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_push_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_push_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::value_type *arg2 = 0 ;
@@ -18914,15 +18914,15 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_push_back(PyObject *self, PyObject *
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_complex_t_push_back", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_complex_T_push_back", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_push_back" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_push_back" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_std_complex_Sl_double_Sg_(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t_push_back" "', argument " "2"" of type '" "std::vector< std::complex< double > >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T_push_back" "', argument " "2"" of type '" "std::vector< std::complex< double > >::value_type""'");
   } 
   temp2 = static_cast< std::vector< std::complex< double > >::value_type >(val2);
   arg2 = &temp2;
@@ -18934,7 +18934,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_front(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_front(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -18947,7 +18947,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_front(PyObject *self, PyObject *args
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_front" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_front" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = (std::vector< std::complex< double > >::value_type *) &((std::vector< std::complex< double > > const *)arg1)->front();
@@ -18959,7 +18959,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -18972,7 +18972,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_back(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_back" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_back" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = (std::vector< std::complex< double > >::value_type *) &((std::vector< std::complex< double > > const *)arg1)->back();
@@ -18984,7 +18984,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_assign(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_assign(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::size_type arg2 ;
@@ -18999,20 +18999,20 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_assign(PyObject *self, PyObject *arg
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_complex_t_assign", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_complex_T_assign", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_assign" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_assign" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t_assign" "', argument " "2"" of type '" "std::vector< std::complex< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T_assign" "', argument " "2"" of type '" "std::vector< std::complex< double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::complex< double > >::size_type >(val2);
   ecode3 = SWIG_AsVal_std_complex_Sl_double_Sg_(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_t_assign" "', argument " "3"" of type '" "std::vector< std::complex< double > >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_T_assign" "', argument " "3"" of type '" "std::vector< std::complex< double > >::value_type""'");
   } 
   temp3 = static_cast< std::vector< std::complex< double > >::value_type >(val3);
   arg3 = &temp3;
@@ -19024,7 +19024,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::size_type arg2 ;
@@ -19041,17 +19041,17 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_resize__SWIG_1(PyObject *self, Py_ss
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_resize" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_resize" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t_resize" "', argument " "2"" of type '" "std::vector< std::complex< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T_resize" "', argument " "2"" of type '" "std::vector< std::complex< double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::complex< double > >::size_type >(val2);
   ecode3 = SWIG_AsVal_std_complex_Sl_double_Sg_(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_t_resize" "', argument " "3"" of type '" "std::vector< std::complex< double > >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_T_resize" "', argument " "3"" of type '" "std::vector< std::complex< double > >::value_type""'");
   } 
   temp3 = static_cast< std::vector< std::complex< double > >::value_type >(val3);
   arg3 = &temp3;
@@ -19063,13 +19063,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_resize(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_resize(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_t_resize", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_T_resize", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -19081,7 +19081,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_resize(PyObject *self, PyObject *arg
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_complex_t_resize__SWIG_0(self, argc, argv);
+        return _wrap_vector_complex_T_resize__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -19100,14 +19100,14 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_resize(PyObject *self, PyObject *arg
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_complex_t_resize__SWIG_1(self, argc, argv);
+          return _wrap_vector_complex_T_resize__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_t_resize'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_T_resize'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::complex< double > >::resize(std::vector< std::complex< double > >::size_type)\n"
     "    std::vector< std::complex< double > >::resize(std::vector< std::complex< double > >::size_type,std::vector< std::complex< double > >::value_type const &)\n");
@@ -19115,7 +19115,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::iterator arg2 ;
@@ -19133,23 +19133,23 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_insert__SWIG_0(PyObject *self, Py_ss
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_insert" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_insert" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t_insert" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T_insert" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t_insert" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T_insert" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_std_complex_Sl_double_Sg_(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_t_insert" "', argument " "3"" of type '" "std::vector< std::complex< double > >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_T_insert" "', argument " "3"" of type '" "std::vector< std::complex< double > >::value_type""'");
   } 
   temp3 = static_cast< std::vector< std::complex< double > >::value_type >(val3);
   arg3 = &temp3;
@@ -19162,7 +19162,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::iterator arg2 ;
@@ -19182,28 +19182,28 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_insert__SWIG_1(PyObject *self, Py_ss
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_insert" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_insert" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t_insert" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T_insert" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t_insert" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T_insert" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_size_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_t_insert" "', argument " "3"" of type '" "std::vector< std::complex< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_T_insert" "', argument " "3"" of type '" "std::vector< std::complex< double > >::size_type""'");
   } 
   arg3 = static_cast< std::vector< std::complex< double > >::size_type >(val3);
   ecode4 = SWIG_AsVal_std_complex_Sl_double_Sg_(swig_obj[3], &val4);
   if (!SWIG_IsOK(ecode4)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode4), "in method '" "vector_complex_t_insert" "', argument " "4"" of type '" "std::vector< std::complex< double > >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode4), "in method '" "vector_complex_T_insert" "', argument " "4"" of type '" "std::vector< std::complex< double > >::value_type""'");
   } 
   temp4 = static_cast< std::vector< std::complex< double > >::value_type >(val4);
   arg4 = &temp4;
@@ -19215,13 +19215,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_insert(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_insert(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_t_insert", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_T_insert", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -19237,7 +19237,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_insert(PyObject *self, PyObject *arg
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_complex_t_insert__SWIG_0(self, argc, argv);
+          return _wrap_vector_complex_T_insert__SWIG_0(self, argc, argv);
         }
       }
     }
@@ -19261,7 +19261,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_insert(PyObject *self, PyObject *arg
             _v = SWIG_CheckState(res);
           }
           if (_v) {
-            return _wrap_vector_complex_t_insert__SWIG_1(self, argc, argv);
+            return _wrap_vector_complex_T_insert__SWIG_1(self, argc, argv);
           }
         }
       }
@@ -19269,7 +19269,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_insert(PyObject *self, PyObject *arg
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_t_insert'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_T_insert'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::complex< double > >::insert(std::vector< std::complex< double > >::iterator,std::vector< std::complex< double > >::value_type const &)\n"
     "    std::vector< std::complex< double > >::insert(std::vector< std::complex< double > >::iterator,std::vector< std::complex< double > >::size_type,std::vector< std::complex< double > >::value_type const &)\n");
@@ -19277,7 +19277,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_reserve(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_reserve(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::size_type arg2 ;
@@ -19288,15 +19288,15 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_reserve(PyObject *self, PyObject *ar
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_complex_t_reserve", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_complex_T_reserve", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_reserve" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_reserve" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t_reserve" "', argument " "2"" of type '" "std::vector< std::complex< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T_reserve" "', argument " "2"" of type '" "std::vector< std::complex< double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::complex< double > >::size_type >(val2);
   (arg1)->reserve(arg2);
@@ -19307,7 +19307,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_capacity(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_capacity(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -19320,7 +19320,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_capacity(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_capacity" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_capacity" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = ((std::vector< std::complex< double > > const *)arg1)->capacity();
@@ -19331,7 +19331,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_delete_vector_complex_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_delete_vector_complex_T(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -19343,7 +19343,7 @@ SWIGINTERN PyObject *_wrap_delete_vector_complex_t(PyObject *self, PyObject *arg
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, SWIG_POINTER_DISOWN |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vector_complex_t" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vector_complex_T" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   {
@@ -19364,18 +19364,18 @@ fail:
 }
 
 
-SWIGINTERN PyObject *vector_complex_t_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vector_complex_T_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   PyObject *obj;
   if (!SWIG_Python_UnpackTuple(args, "swigregister", 1, 1, &obj)) return NULL;
   SWIG_TypeNewClientData(SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, SWIG_NewClientData(obj));
   return SWIG_Py_Void();
 }
 
-SWIGINTERN PyObject *vector_complex_t_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vector_complex_T_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   return SWIG_Python_InitShadowInstance(args);
 }
 
-SWIGINTERN PyObject *_wrap_vector_string_t_iterator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_iterator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   PyObject **arg2 = (PyObject **) 0 ;
@@ -19390,7 +19390,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_iterator(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_iterator" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_iterator" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = (swig::SwigPyIterator *)std_vector_Sl_std_string_Sg__iterator(arg1,arg2);
@@ -19401,7 +19401,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___nonzero__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T___nonzero__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -19414,7 +19414,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t___nonzero__(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___nonzero__" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___nonzero__" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = (bool)std_vector_Sl_std_string_Sg____nonzero__((std::vector< std::string > const *)arg1);
@@ -19425,7 +19425,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___bool__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T___bool__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -19438,7 +19438,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t___bool__(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___bool__" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___bool__" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = (bool)std_vector_Sl_std_string_Sg____bool__((std::vector< std::string > const *)arg1);
@@ -19449,7 +19449,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___len__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T___len__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -19462,7 +19462,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t___len__(PyObject *self, PyObject *arg
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___len__" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___len__" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = std_vector_Sl_std_string_Sg____len__((std::vector< std::string > const *)arg1);
@@ -19473,7 +19473,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___getslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T___getslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::difference_type arg2 ;
@@ -19488,20 +19488,20 @@ SWIGINTERN PyObject *_wrap_vector_string_t___getslice__(PyObject *self, PyObject
   std::vector< std::string,std::allocator< std::string > > *result = 0 ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_string_t___getslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_string_T___getslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___getslice__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___getslice__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_t___getslice__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_T___getslice__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::string >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_string_t___getslice__" "', argument " "3"" of type '" "std::vector< std::string >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_string_T___getslice__" "', argument " "3"" of type '" "std::vector< std::string >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::string >::difference_type >(val3);
   try {
@@ -19518,7 +19518,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::difference_type arg2 ;
@@ -19534,17 +19534,17 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setslice____SWIG_0(PyObject *self,
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___setslice__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___setslice__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_t___setslice__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_T___setslice__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::string >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_string_t___setslice__" "', argument " "3"" of type '" "std::vector< std::string >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_string_T___setslice__" "', argument " "3"" of type '" "std::vector< std::string >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::string >::difference_type >(val3);
   try {
@@ -19561,7 +19561,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::difference_type arg2 ;
@@ -19579,27 +19579,27 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setslice____SWIG_1(PyObject *self,
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___setslice__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___setslice__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_t___setslice__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_T___setslice__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::string >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_string_t___setslice__" "', argument " "3"" of type '" "std::vector< std::string >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_string_T___setslice__" "', argument " "3"" of type '" "std::vector< std::string >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::string >::difference_type >(val3);
   {
     std::vector< std::string,std::allocator< std::string > > *ptr = (std::vector< std::string,std::allocator< std::string > > *)0;
     res4 = swig::asptr(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_string_t___setslice__" "', argument " "4"" of type '" "std::vector< std::string,std::allocator< std::string > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_string_T___setslice__" "', argument " "4"" of type '" "std::vector< std::string,std::allocator< std::string > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_t___setslice__" "', argument " "4"" of type '" "std::vector< std::string,std::allocator< std::string > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_T___setslice__" "', argument " "4"" of type '" "std::vector< std::string,std::allocator< std::string > > const &""'"); 
     }
     arg4 = ptr;
   }
@@ -19619,13 +19619,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___setslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T___setslice__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_t___setslice__", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_T___setslice__", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -19642,7 +19642,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setslice__(PyObject *self, PyObject
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_string_t___setslice____SWIG_0(self, argc, argv);
+          return _wrap_vector_string_T___setslice____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -19665,7 +19665,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setslice__(PyObject *self, PyObject
           int res = swig::asptr(argv[3], (std::vector< std::string,std::allocator< std::string > >**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vector_string_t___setslice____SWIG_1(self, argc, argv);
+            return _wrap_vector_string_T___setslice____SWIG_1(self, argc, argv);
           }
         }
       }
@@ -19673,7 +19673,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setslice__(PyObject *self, PyObject
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_t___setslice__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_T___setslice__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::string >::__setslice__(std::vector< std::string >::difference_type,std::vector< std::string >::difference_type)\n"
     "    std::vector< std::string >::__setslice__(std::vector< std::string >::difference_type,std::vector< std::string >::difference_type,std::vector< std::string,std::allocator< std::string > > const &)\n");
@@ -19681,7 +19681,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___delslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T___delslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::difference_type arg2 ;
@@ -19695,20 +19695,20 @@ SWIGINTERN PyObject *_wrap_vector_string_t___delslice__(PyObject *self, PyObject
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_string_t___delslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_string_T___delslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___delslice__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___delslice__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_t___delslice__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_T___delslice__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::string >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_string_t___delslice__" "', argument " "3"" of type '" "std::vector< std::string >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_string_T___delslice__" "', argument " "3"" of type '" "std::vector< std::string >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::string >::difference_type >(val3);
   try {
@@ -19725,7 +19725,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::difference_type arg2 ;
@@ -19738,12 +19738,12 @@ SWIGINTERN PyObject *_wrap_vector_string_t___delitem____SWIG_0(PyObject *self, P
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___delitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___delitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_t___delitem__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_T___delitem__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::string >::difference_type >(val2);
   try {
@@ -19760,7 +19760,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -19772,12 +19772,12 @@ SWIGINTERN PyObject *_wrap_vector_string_t___getitem____SWIG_0(PyObject *self, P
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___getitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___getitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -19795,7 +19795,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -19808,12 +19808,12 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setitem____SWIG_0(PyObject *self, P
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___setitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___setitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -19821,10 +19821,10 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setitem____SWIG_0(PyObject *self, P
     std::vector< std::string,std::allocator< std::string > > *ptr = (std::vector< std::string,std::allocator< std::string > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_string_t___setitem__" "', argument " "3"" of type '" "std::vector< std::string,std::allocator< std::string > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_string_T___setitem__" "', argument " "3"" of type '" "std::vector< std::string,std::allocator< std::string > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_t___setitem__" "', argument " "3"" of type '" "std::vector< std::string,std::allocator< std::string > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_T___setitem__" "', argument " "3"" of type '" "std::vector< std::string,std::allocator< std::string > > const &""'"); 
     }
     arg3 = ptr;
   }
@@ -19844,7 +19844,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -19855,12 +19855,12 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setitem____SWIG_1(PyObject *self, P
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___setitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___setitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -19878,7 +19878,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -19889,12 +19889,12 @@ SWIGINTERN PyObject *_wrap_vector_string_t___delitem____SWIG_1(PyObject *self, P
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___delitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___delitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -19912,13 +19912,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___delitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T___delitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_t___delitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_T___delitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -19929,7 +19929,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t___delitem__(PyObject *self, PyObject
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_string_t___delitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_string_T___delitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -19943,13 +19943,13 @@ SWIGINTERN PyObject *_wrap_vector_string_t___delitem__(PyObject *self, PyObject
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_string_t___delitem____SWIG_0(self, argc, argv);
+        return _wrap_vector_string_T___delitem____SWIG_0(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_t___delitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_T___delitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::string >::__delitem__(std::vector< std::string >::difference_type)\n"
     "    std::vector< std::string >::__delitem__(SWIGPY_SLICEOBJECT *)\n");
@@ -19957,7 +19957,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::difference_type arg2 ;
@@ -19971,12 +19971,12 @@ SWIGINTERN PyObject *_wrap_vector_string_t___getitem____SWIG_1(PyObject *self, P
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___getitem__" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___getitem__" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_t___getitem__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_T___getitem__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::string >::difference_type >(val2);
   try {
@@ -19992,13 +19992,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___getitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T___getitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_t___getitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_T___getitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -20009,7 +20009,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t___getitem__(PyObject *self, PyObject
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_string_t___getitem____SWIG_0(self, argc, argv);
+        return _wrap_vector_string_T___getitem____SWIG_0(self, argc, argv);
       }
     }
   }
@@ -20023,13 +20023,13 @@ SWIGINTERN PyObject *_wrap_vector_string_t___getitem__(PyObject *self, PyObject
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_string_t___getitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_string_T___getitem____SWIG_1(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_t___getitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_T___getitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::string >::__getitem__(SWIGPY_SLICEOBJECT *)\n"
     "    std::vector< std::string >::__getitem__(std::vector< std::string >::difference_type) const\n");
@@ -20037,7 +20037,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::difference_type arg2 ;
@@ -20052,22 +20052,22 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setitem____SWIG_2(PyObject *self, P
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___setitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___setitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_t___setitem__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_T___setitem__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::string >::difference_type >(val2);
   {
     std::string *ptr = (std::string *)0;
     res3 = SWIG_AsPtr_std_string(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_string_t___setitem__" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_string_T___setitem__" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_t___setitem__" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_T___setitem__" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -20085,13 +20085,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___setitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T___setitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_t___setitem__", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_T___setitem__", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -20102,7 +20102,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setitem__(PyObject *self, PyObject
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_string_t___setitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_string_T___setitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -20118,7 +20118,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setitem__(PyObject *self, PyObject
         int res = swig::asptr(argv[2], (std::vector< std::string,std::allocator< std::string > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vector_string_t___setitem____SWIG_0(self, argc, argv);
+          return _wrap_vector_string_T___setitem____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -20136,14 +20136,14 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setitem__(PyObject *self, PyObject
         int res = SWIG_AsPtr_std_string(argv[2], (std::string**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vector_string_t___setitem____SWIG_2(self, argc, argv);
+          return _wrap_vector_string_T___setitem____SWIG_2(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_t___setitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_T___setitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::string >::__setitem__(SWIGPY_SLICEOBJECT *,std::vector< std::string,std::allocator< std::string > > const &)\n"
     "    std::vector< std::string >::__setitem__(SWIGPY_SLICEOBJECT *)\n"
@@ -20152,7 +20152,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_pop(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_pop(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -20165,7 +20165,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_pop(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_pop" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_pop" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   try {
@@ -20180,7 +20180,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_append(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_append(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::value_type *arg2 = 0 ;
@@ -20190,20 +20190,20 @@ SWIGINTERN PyObject *_wrap_vector_string_t_append(PyObject *self, PyObject *args
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_string_t_append", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_string_T_append", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_append" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_append" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_string_t_append" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_string_T_append" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_t_append" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_T_append" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -20217,7 +20217,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_string_t__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
+SWIGINTERN PyObject *_wrap_new_vector_string_T__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
   PyObject *resultobj = 0;
   std::vector< std::string > *result = 0 ;
   
@@ -20231,7 +20231,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_string_t__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_string_T__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = 0 ;
   int res1 = SWIG_OLDOBJ ;
@@ -20243,10 +20243,10 @@ SWIGINTERN PyObject *_wrap_new_vector_string_t__SWIG_1(PyObject *self, Py_ssize_
     std::vector< std::string,std::allocator< std::string > > *ptr = (std::vector< std::string,std::allocator< std::string > > *)0;
     res1 = swig::asptr(swig_obj[0], &ptr);
     if (!SWIG_IsOK(res1)) {
-      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vector_string_t" "', argument " "1"" of type '" "std::vector< std::string > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vector_string_T" "', argument " "1"" of type '" "std::vector< std::string > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_string_t" "', argument " "1"" of type '" "std::vector< std::string > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_string_T" "', argument " "1"" of type '" "std::vector< std::string > const &""'"); 
     }
     arg1 = ptr;
   }
@@ -20260,7 +20260,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_empty(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_empty(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -20273,7 +20273,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_empty(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_empty" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_empty" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = (bool)((std::vector< std::string > const *)arg1)->empty();
@@ -20284,7 +20284,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_size(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_size(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -20297,7 +20297,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_size(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_size" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_size" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = ((std::vector< std::string > const *)arg1)->size();
@@ -20308,7 +20308,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_swap(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_swap(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string > *arg2 = 0 ;
@@ -20319,18 +20319,18 @@ SWIGINTERN PyObject *_wrap_vector_string_t_swap(PyObject *self, PyObject *args)
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_string_t_swap", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_string_T_swap", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_swap" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_swap" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], &argp2, SWIGTYPE_p_std__vectorT_std__string_t,  0 );
   if (!SWIG_IsOK(res2)) {
-    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_string_t_swap" "', argument " "2"" of type '" "std::vector< std::string > &""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_string_T_swap" "', argument " "2"" of type '" "std::vector< std::string > &""'"); 
   }
   if (!argp2) {
-    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_t_swap" "', argument " "2"" of type '" "std::vector< std::string > &""'"); 
+    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_T_swap" "', argument " "2"" of type '" "std::vector< std::string > &""'"); 
   }
   arg2 = reinterpret_cast< std::vector< std::string > * >(argp2);
   (arg1)->swap(*arg2);
@@ -20341,7 +20341,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_begin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_begin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -20354,7 +20354,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_begin(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_begin" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_begin" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = (arg1)->begin();
@@ -20366,7 +20366,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_end(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_end(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -20379,7 +20379,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_end(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_end" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_end" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = (arg1)->end();
@@ -20391,7 +20391,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_rbegin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_rbegin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -20404,7 +20404,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_rbegin(PyObject *self, PyObject *args
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_rbegin" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_rbegin" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = (arg1)->rbegin();
@@ -20416,7 +20416,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_rend(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_rend(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -20429,7 +20429,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_rend(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_rend" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_rend" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = (arg1)->rend();
@@ -20441,7 +20441,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_clear(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_clear(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -20453,7 +20453,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_clear(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_clear" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_clear" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   (arg1)->clear();
@@ -20464,7 +20464,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_get_allocator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_get_allocator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -20477,7 +20477,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_get_allocator(PyObject *self, PyObjec
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_get_allocator" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_get_allocator" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = ((std::vector< std::string > const *)arg1)->get_allocator();
@@ -20488,7 +20488,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_string_t__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_string_T__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string >::size_type arg1 ;
   size_t val1 ;
@@ -20499,7 +20499,7 @@ SWIGINTERN PyObject *_wrap_new_vector_string_t__SWIG_2(PyObject *self, Py_ssize_
   if ((nobjs < 1) || (nobjs > 1)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_string_t" "', argument " "1"" of type '" "std::vector< std::string >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_string_T" "', argument " "1"" of type '" "std::vector< std::string >::size_type""'");
   } 
   arg1 = static_cast< std::vector< std::string >::size_type >(val1);
   result = (std::vector< std::string > *)new std::vector< std::string >(arg1);
@@ -20510,7 +20510,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_pop_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_pop_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -20522,7 +20522,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_pop_back(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_pop_back" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_pop_back" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   (arg1)->pop_back();
@@ -20533,7 +20533,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::size_type arg2 ;
@@ -20546,12 +20546,12 @@ SWIGINTERN PyObject *_wrap_vector_string_t_resize__SWIG_0(PyObject *self, Py_ssi
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_resize" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_resize" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_t_resize" "', argument " "2"" of type '" "std::vector< std::string >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_T_resize" "', argument " "2"" of type '" "std::vector< std::string >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::string >::size_type >(val2);
   (arg1)->resize(arg2);
@@ -20562,7 +20562,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::iterator arg2 ;
@@ -20576,18 +20576,18 @@ SWIGINTERN PyObject *_wrap_vector_string_t_erase__SWIG_0(PyObject *self, Py_ssiz
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_erase" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_erase" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t_erase" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T_erase" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::string >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::string >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t_erase" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T_erase" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
     }
   }
   result = std_vector_Sl_std_string_Sg__erase__SWIG_0(arg1,SWIG_STD_MOVE(arg2));
@@ -20599,7 +20599,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::iterator arg2 ;
@@ -20616,29 +20616,29 @@ SWIGINTERN PyObject *_wrap_vector_string_t_erase__SWIG_1(PyObject *self, Py_ssiz
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_erase" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_erase" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t_erase" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T_erase" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::string >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::string >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t_erase" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T_erase" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
     }
   }
   res3 = SWIG_ConvertPtr(swig_obj[2], SWIG_as_voidptrptr(&iter3), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res3) || !iter3) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t_erase" "', argument " "3"" of type '" "std::vector< std::string >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T_erase" "', argument " "3"" of type '" "std::vector< std::string >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::string >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::string >::iterator > *>(iter3);
     if (iter_t) {
       arg3 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t_erase" "', argument " "3"" of type '" "std::vector< std::string >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T_erase" "', argument " "3"" of type '" "std::vector< std::string >::iterator""'");
     }
   }
   result = std_vector_Sl_std_string_Sg__erase__SWIG_1(arg1,SWIG_STD_MOVE(arg2),SWIG_STD_MOVE(arg3));
@@ -20650,13 +20650,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_erase(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_erase(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_t_erase", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_T_erase", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -20667,7 +20667,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_erase(PyObject *self, PyObject *args)
       int res = SWIG_ConvertPtr(argv[1], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
       _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< std::string >::iterator > *>(iter) != 0));
       if (_v) {
-        return _wrap_vector_string_t_erase__SWIG_0(self, argc, argv);
+        return _wrap_vector_string_T_erase__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -20684,14 +20684,14 @@ SWIGINTERN PyObject *_wrap_vector_string_t_erase(PyObject *self, PyObject *args)
         int res = SWIG_ConvertPtr(argv[2], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
         _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< std::string >::iterator > *>(iter) != 0));
         if (_v) {
-          return _wrap_vector_string_t_erase__SWIG_1(self, argc, argv);
+          return _wrap_vector_string_T_erase__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_t_erase'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_T_erase'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::string >::erase(std::vector< std::string >::iterator)\n"
     "    std::vector< std::string >::erase(std::vector< std::string >::iterator,std::vector< std::string >::iterator)\n");
@@ -20699,7 +20699,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_string_t__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_string_T__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string >::size_type arg1 ;
   std::vector< std::string >::value_type *arg2 = 0 ;
@@ -20712,17 +20712,17 @@ SWIGINTERN PyObject *_wrap_new_vector_string_t__SWIG_3(PyObject *self, Py_ssize_
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_string_t" "', argument " "1"" of type '" "std::vector< std::string >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_string_T" "', argument " "1"" of type '" "std::vector< std::string >::size_type""'");
   } 
   arg1 = static_cast< std::vector< std::string >::size_type >(val1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "new_vector_string_t" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "new_vector_string_T" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_string_t" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_string_T" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -20736,16 +20736,16 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_string_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_new_vector_string_T(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vector_string_t", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vector_string_T", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 0) {
-    return _wrap_new_vector_string_t__SWIG_0(self, argc, argv);
+    return _wrap_new_vector_string_T__SWIG_0(self, argc, argv);
   }
   if (argc == 1) {
     int _v = 0;
@@ -20754,7 +20754,7 @@ SWIGINTERN PyObject *_wrap_new_vector_string_t(PyObject *self, PyObject *args) {
       _v = SWIG_CheckState(res);
     }
     if (_v) {
-      return _wrap_new_vector_string_t__SWIG_2(self, argc, argv);
+      return _wrap_new_vector_string_T__SWIG_2(self, argc, argv);
     }
   }
   if (argc == 1) {
@@ -20762,7 +20762,7 @@ SWIGINTERN PyObject *_wrap_new_vector_string_t(PyObject *self, PyObject *args) {
     int res = swig::asptr(argv[0], (std::vector< std::string,std::allocator< std::string > >**)(0));
     _v = SWIG_CheckState(res);
     if (_v) {
-      return _wrap_new_vector_string_t__SWIG_1(self, argc, argv);
+      return _wrap_new_vector_string_T__SWIG_1(self, argc, argv);
     }
   }
   if (argc == 2) {
@@ -20775,13 +20775,13 @@ SWIGINTERN PyObject *_wrap_new_vector_string_t(PyObject *self, PyObject *args) {
       int res = SWIG_AsPtr_std_string(argv[1], (std::string**)(0));
       _v = SWIG_CheckState(res);
       if (_v) {
-        return _wrap_new_vector_string_t__SWIG_3(self, argc, argv);
+        return _wrap_new_vector_string_T__SWIG_3(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vector_string_t'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vector_string_T'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::string >::vector()\n"
     "    std::vector< std::string >::vector(std::vector< std::string > const &)\n"
@@ -20791,7 +20791,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_push_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_push_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::value_type *arg2 = 0 ;
@@ -20801,20 +20801,20 @@ SWIGINTERN PyObject *_wrap_vector_string_t_push_back(PyObject *self, PyObject *a
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_string_t_push_back", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_string_T_push_back", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_push_back" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_push_back" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_string_t_push_back" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_string_T_push_back" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_t_push_back" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_T_push_back" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -20828,7 +20828,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_front(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_front(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -20841,7 +20841,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_front(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_front" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_front" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = (std::vector< std::string >::value_type *) &((std::vector< std::string > const *)arg1)->front();
@@ -20853,7 +20853,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -20866,7 +20866,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_back(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_back" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_back" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = (std::vector< std::string >::value_type *) &((std::vector< std::string > const *)arg1)->back();
@@ -20878,7 +20878,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_assign(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_assign(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::size_type arg2 ;
@@ -20891,25 +20891,25 @@ SWIGINTERN PyObject *_wrap_vector_string_t_assign(PyObject *self, PyObject *args
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_string_t_assign", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_string_T_assign", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_assign" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_assign" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_t_assign" "', argument " "2"" of type '" "std::vector< std::string >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_T_assign" "', argument " "2"" of type '" "std::vector< std::string >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::string >::size_type >(val2);
   {
     std::string *ptr = (std::string *)0;
     res3 = SWIG_AsPtr_std_string(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_string_t_assign" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_string_T_assign" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_t_assign" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_T_assign" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -20923,7 +20923,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::size_type arg2 ;
@@ -20938,22 +20938,22 @@ SWIGINTERN PyObject *_wrap_vector_string_t_resize__SWIG_1(PyObject *self, Py_ssi
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_resize" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_resize" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_t_resize" "', argument " "2"" of type '" "std::vector< std::string >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_T_resize" "', argument " "2"" of type '" "std::vector< std::string >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::string >::size_type >(val2);
   {
     std::string *ptr = (std::string *)0;
     res3 = SWIG_AsPtr_std_string(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_string_t_resize" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_string_T_resize" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_t_resize" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_T_resize" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -20967,13 +20967,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_resize(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_resize(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_t_resize", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_T_resize", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -20985,7 +20985,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_resize(PyObject *self, PyObject *args
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_string_t_resize__SWIG_0(self, argc, argv);
+        return _wrap_vector_string_T_resize__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -21002,14 +21002,14 @@ SWIGINTERN PyObject *_wrap_vector_string_t_resize(PyObject *self, PyObject *args
         int res = SWIG_AsPtr_std_string(argv[2], (std::string**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vector_string_t_resize__SWIG_1(self, argc, argv);
+          return _wrap_vector_string_T_resize__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_t_resize'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_T_resize'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::string >::resize(std::vector< std::string >::size_type)\n"
     "    std::vector< std::string >::resize(std::vector< std::string >::size_type,std::vector< std::string >::value_type const &)\n");
@@ -21017,7 +21017,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::iterator arg2 ;
@@ -21033,28 +21033,28 @@ SWIGINTERN PyObject *_wrap_vector_string_t_insert__SWIG_0(PyObject *self, Py_ssi
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_insert" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_insert" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t_insert" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T_insert" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::string >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::string >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t_insert" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T_insert" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
     }
   }
   {
     std::string *ptr = (std::string *)0;
     res3 = SWIG_AsPtr_std_string(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_string_t_insert" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_string_T_insert" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_t_insert" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_T_insert" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -21069,7 +21069,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::iterator arg2 ;
@@ -21087,33 +21087,33 @@ SWIGINTERN PyObject *_wrap_vector_string_t_insert__SWIG_1(PyObject *self, Py_ssi
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_insert" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_insert" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t_insert" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T_insert" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::string >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::string >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t_insert" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T_insert" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_size_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_string_t_insert" "', argument " "3"" of type '" "std::vector< std::string >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_string_T_insert" "', argument " "3"" of type '" "std::vector< std::string >::size_type""'");
   } 
   arg3 = static_cast< std::vector< std::string >::size_type >(val3);
   {
     std::string *ptr = (std::string *)0;
     res4 = SWIG_AsPtr_std_string(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_string_t_insert" "', argument " "4"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_string_T_insert" "', argument " "4"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_t_insert" "', argument " "4"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_T_insert" "', argument " "4"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     arg4 = ptr;
   }
@@ -21127,13 +21127,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_insert(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_insert(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_t_insert", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_T_insert", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -21147,7 +21147,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_insert(PyObject *self, PyObject *args
         int res = SWIG_AsPtr_std_string(argv[2], (std::string**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vector_string_t_insert__SWIG_0(self, argc, argv);
+          return _wrap_vector_string_T_insert__SWIG_0(self, argc, argv);
         }
       }
     }
@@ -21169,7 +21169,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_insert(PyObject *self, PyObject *args
           int res = SWIG_AsPtr_std_string(argv[3], (std::string**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vector_string_t_insert__SWIG_1(self, argc, argv);
+            return _wrap_vector_string_T_insert__SWIG_1(self, argc, argv);
           }
         }
       }
@@ -21177,7 +21177,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_insert(PyObject *self, PyObject *args
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_t_insert'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_T_insert'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::string >::insert(std::vector< std::string >::iterator,std::vector< std::string >::value_type const &)\n"
     "    std::vector< std::string >::insert(std::vector< std::string >::iterator,std::vector< std::string >::size_type,std::vector< std::string >::value_type const &)\n");
@@ -21185,7 +21185,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_reserve(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_reserve(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::size_type arg2 ;
@@ -21196,15 +21196,15 @@ SWIGINTERN PyObject *_wrap_vector_string_t_reserve(PyObject *self, PyObject *arg
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_string_t_reserve", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_string_T_reserve", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_reserve" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_reserve" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_t_reserve" "', argument " "2"" of type '" "std::vector< std::string >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_T_reserve" "', argument " "2"" of type '" "std::vector< std::string >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::string >::size_type >(val2);
   (arg1)->reserve(arg2);
@@ -21215,7 +21215,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_capacity(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_capacity(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -21228,7 +21228,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_capacity(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_capacity" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_capacity" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = ((std::vector< std::string > const *)arg1)->capacity();
@@ -21239,7 +21239,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_delete_vector_string_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_delete_vector_string_T(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -21251,7 +21251,7 @@ SWIGINTERN PyObject *_wrap_delete_vector_string_t(PyObject *self, PyObject *args
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, SWIG_POINTER_DISOWN |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vector_string_t" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vector_string_T" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   {
@@ -21272,18 +21272,18 @@ fail:
 }
 
 
-SWIGINTERN PyObject *vector_string_t_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vector_string_T_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   PyObject *obj;
   if (!SWIG_Python_UnpackTuple(args, "swigregister", 1, 1, &obj)) return NULL;
   SWIG_TypeNewClientData(SWIGTYPE_p_std__vectorT_std__string_t, SWIG_NewClientData(obj));
   return SWIG_Py_Void();
 }
 
-SWIGINTERN PyObject *vector_string_t_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vector_string_T_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   return SWIG_Python_InitShadowInstance(args);
 }
 
-SWIGINTERN PyObject *_wrap_new_map_string_double_t__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_map_string_double_T__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::less< std::string > *arg1 = 0 ;
   void *argp1 = 0 ;
@@ -21294,10 +21294,10 @@ SWIGINTERN PyObject *_wrap_new_map_string_double_t__SWIG_0(PyObject *self, Py_ss
   if ((nobjs < 1) || (nobjs > 1)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1, SWIGTYPE_p_std__lessT_std__string_t,  0  | 0);
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_map_string_double_t" "', argument " "1"" of type '" "std::less< std::string > const &""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_map_string_double_T" "', argument " "1"" of type '" "std::less< std::string > const &""'"); 
   }
   if (!argp1) {
-    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_map_string_double_t" "', argument " "1"" of type '" "std::less< std::string > const &""'"); 
+    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_map_string_double_T" "', argument " "1"" of type '" "std::less< std::string > const &""'"); 
   }
   arg1 = reinterpret_cast< std::less< std::string > * >(argp1);
   result = (std::map< std::string,double > *)new std::map< std::string,double >((std::less< std::string > const &)*arg1);
@@ -21308,7 +21308,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_iterator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_iterator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   PyObject **arg2 = (PyObject **) 0 ;
@@ -21323,7 +21323,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_iterator(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_iterator" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_iterator" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (swig::SwigPyIterator *)std_map_Sl_std_string_Sc_double_Sg__iterator(arg1,arg2);
@@ -21334,7 +21334,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t___nonzero__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T___nonzero__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -21347,7 +21347,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t___nonzero__(PyObject *self, PyObj
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t___nonzero__" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T___nonzero__" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (bool)std_map_Sl_std_string_Sc_double_Sg____nonzero__((std::map< std::string,double > const *)arg1);
@@ -21358,7 +21358,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t___bool__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T___bool__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -21371,7 +21371,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t___bool__(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t___bool__" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T___bool__" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (bool)std_map_Sl_std_string_Sc_double_Sg____bool__((std::map< std::string,double > const *)arg1);
@@ -21382,7 +21382,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t___len__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T___len__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -21395,7 +21395,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t___len__(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t___len__" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T___len__" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = std_map_Sl_std_string_Sc_double_Sg____len__((std::map< std::string,double > const *)arg1);
@@ -21406,7 +21406,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t___getitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T___getitem__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::key_type *arg2 = 0 ;
@@ -21417,20 +21417,20 @@ SWIGINTERN PyObject *_wrap_map_string_double_t___getitem__(PyObject *self, PyObj
   std::map< std::string,double >::mapped_type *result = 0 ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "map_string_double_t___getitem__", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "map_string_double_T___getitem__", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t___getitem__" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T___getitem__" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t___getitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T___getitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t___getitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T___getitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -21448,7 +21448,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t___delitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T___delitem__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::key_type *arg2 = 0 ;
@@ -21458,20 +21458,20 @@ SWIGINTERN PyObject *_wrap_map_string_double_t___delitem__(PyObject *self, PyObj
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "map_string_double_t___delitem__", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "map_string_double_T___delitem__", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t___delitem__" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T___delitem__" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t___delitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T___delitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t___delitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T___delitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -21489,7 +21489,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_has_key(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_has_key(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::key_type *arg2 = 0 ;
@@ -21500,20 +21500,20 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_has_key(PyObject *self, PyObject
   bool result;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "map_string_double_t_has_key", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "map_string_double_T_has_key", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_has_key" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_has_key" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t_has_key" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T_has_key" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t_has_key" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T_has_key" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -21527,7 +21527,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_keys(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_keys(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -21540,7 +21540,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_keys(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_keys" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_keys" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (PyObject *)std_map_Sl_std_string_Sc_double_Sg__keys(arg1);
@@ -21551,7 +21551,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_values(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_values(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -21564,7 +21564,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_values(PyObject *self, PyObject *
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_values" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_values" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (PyObject *)std_map_Sl_std_string_Sc_double_Sg__values(arg1);
@@ -21575,7 +21575,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_items(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_items(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -21588,7 +21588,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_items(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_items" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_items" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (PyObject *)std_map_Sl_std_string_Sc_double_Sg__items(arg1);
@@ -21599,7 +21599,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t___contains__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T___contains__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::key_type *arg2 = 0 ;
@@ -21610,20 +21610,20 @@ SWIGINTERN PyObject *_wrap_map_string_double_t___contains__(PyObject *self, PyOb
   bool result;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "map_string_double_t___contains__", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "map_string_double_T___contains__", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t___contains__" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T___contains__" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t___contains__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T___contains__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t___contains__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T___contains__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -21637,7 +21637,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_key_iterator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_key_iterator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   PyObject **arg2 = (PyObject **) 0 ;
@@ -21652,7 +21652,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_key_iterator(PyObject *self, PyOb
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_key_iterator" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_key_iterator" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (swig::SwigPyIterator *)std_map_Sl_std_string_Sc_double_Sg__key_iterator(arg1,arg2);
@@ -21663,7 +21663,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_value_iterator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_value_iterator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   PyObject **arg2 = (PyObject **) 0 ;
@@ -21678,7 +21678,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_value_iterator(PyObject *self, Py
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_value_iterator" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_value_iterator" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (swig::SwigPyIterator *)std_map_Sl_std_string_Sc_double_Sg__value_iterator(arg1,arg2);
@@ -21689,7 +21689,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_map_string_double_T___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::key_type *arg2 = 0 ;
@@ -21701,17 +21701,17 @@ SWIGINTERN PyObject *_wrap_map_string_double_t___setitem____SWIG_0(PyObject *sel
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t___setitem__" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T___setitem__" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t___setitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T___setitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t___setitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T___setitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -21725,7 +21725,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_map_string_double_T___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::key_type *arg2 = 0 ;
@@ -21741,23 +21741,23 @@ SWIGINTERN PyObject *_wrap_map_string_double_t___setitem____SWIG_1(PyObject *sel
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t___setitem__" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T___setitem__" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t___setitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T___setitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t___setitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T___setitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     arg2 = ptr;
   }
   ecode3 = SWIG_AsVal_double(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "map_string_double_t___setitem__" "', argument " "3"" of type '" "std::map< std::string,double >::mapped_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "map_string_double_T___setitem__" "', argument " "3"" of type '" "std::map< std::string,double >::mapped_type""'");
   } 
   temp3 = static_cast< std::map< std::string,double >::mapped_type >(val3);
   arg3 = &temp3;
@@ -21775,13 +21775,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t___setitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T___setitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "map_string_double_t___setitem__", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "map_string_double_T___setitem__", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -21791,7 +21791,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t___setitem__(PyObject *self, PyObj
       int res = SWIG_AsPtr_std_string(argv[1], (std::string**)(0));
       _v = SWIG_CheckState(res);
       if (_v) {
-        return _wrap_map_string_double_t___setitem____SWIG_0(self, argc, argv);
+        return _wrap_map_string_double_T___setitem____SWIG_0(self, argc, argv);
       }
     }
   }
@@ -21808,14 +21808,14 @@ SWIGINTERN PyObject *_wrap_map_string_double_t___setitem__(PyObject *self, PyObj
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_map_string_double_t___setitem____SWIG_1(self, argc, argv);
+          return _wrap_map_string_double_T___setitem____SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'map_string_double_t___setitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'map_string_double_T___setitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::map< std::string,double >::__setitem__(std::map< std::string,double >::key_type const &)\n"
     "    std::map< std::string,double >::__setitem__(std::map< std::string,double >::key_type const &,std::map< std::string,double >::mapped_type const &)\n");
@@ -21823,7 +21823,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_asdict(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_asdict(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -21836,7 +21836,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_asdict(PyObject *self, PyObject *
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_asdict" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_asdict" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (PyObject *)std_map_Sl_std_string_Sc_double_Sg__asdict(arg1);
@@ -21847,7 +21847,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_map_string_double_t__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
+SWIGINTERN PyObject *_wrap_new_map_string_double_T__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *result = 0 ;
   
@@ -21861,7 +21861,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_map_string_double_t__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_map_string_double_T__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = 0 ;
   int res1 = SWIG_OLDOBJ ;
@@ -21873,10 +21873,10 @@ SWIGINTERN PyObject *_wrap_new_map_string_double_t__SWIG_2(PyObject *self, Py_ss
     std::map< std::string,double,std::less< std::string >,std::allocator< std::pair< std::string const,double > > > *ptr = (std::map< std::string,double,std::less< std::string >,std::allocator< std::pair< std::string const,double > > > *)0;
     res1 = swig::asptr(swig_obj[0], &ptr);
     if (!SWIG_IsOK(res1)) {
-      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_map_string_double_t" "', argument " "1"" of type '" "std::map< std::string,double > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_map_string_double_T" "', argument " "1"" of type '" "std::map< std::string,double > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_map_string_double_t" "', argument " "1"" of type '" "std::map< std::string,double > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_map_string_double_T" "', argument " "1"" of type '" "std::map< std::string,double > const &""'"); 
     }
     arg1 = ptr;
   }
@@ -21890,23 +21890,23 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_map_string_double_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_new_map_string_double_T(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[2] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "new_map_string_double_t", 0, 1, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "new_map_string_double_T", 0, 1, argv))) SWIG_fail;
   --argc;
   if (argc == 0) {
-    return _wrap_new_map_string_double_t__SWIG_1(self, argc, argv);
+    return _wrap_new_map_string_double_T__SWIG_1(self, argc, argv);
   }
   if (argc == 1) {
     int _v = 0;
     int res = SWIG_ConvertPtr(argv[0], 0, SWIGTYPE_p_std__lessT_std__string_t, SWIG_POINTER_NO_NULL | 0);
     _v = SWIG_CheckState(res);
     if (_v) {
-      return _wrap_new_map_string_double_t__SWIG_0(self, argc, argv);
+      return _wrap_new_map_string_double_T__SWIG_0(self, argc, argv);
     }
   }
   if (argc == 1) {
@@ -21914,12 +21914,12 @@ SWIGINTERN PyObject *_wrap_new_map_string_double_t(PyObject *self, PyObject *arg
     int res = swig::asptr(argv[0], (std::map< std::string,double,std::less< std::string >,std::allocator< std::pair< std::string const,double > > >**)(0));
     _v = SWIG_CheckState(res);
     if (_v) {
-      return _wrap_new_map_string_double_t__SWIG_2(self, argc, argv);
+      return _wrap_new_map_string_double_T__SWIG_2(self, argc, argv);
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_map_string_double_t'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_map_string_double_T'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::map< std::string,double >::map(std::less< std::string > const &)\n"
     "    std::map< std::string,double >::map()\n"
@@ -21928,7 +21928,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_empty(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_empty(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -21941,7 +21941,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_empty(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_empty" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_empty" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (bool)((std::map< std::string,double > const *)arg1)->empty();
@@ -21952,7 +21952,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_size(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_size(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -21965,7 +21965,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_size(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_size" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_size" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = ((std::map< std::string,double > const *)arg1)->size();
@@ -21976,7 +21976,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_swap(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_swap(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double > *arg2 = 0 ;
@@ -21987,18 +21987,18 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_swap(PyObject *self, PyObject *ar
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "map_string_double_t_swap", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "map_string_double_T_swap", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_swap" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_swap" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], &argp2, SWIGTYPE_p_std__mapT_std__string_double_t,  0 );
   if (!SWIG_IsOK(res2)) {
-    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t_swap" "', argument " "2"" of type '" "std::map< std::string,double > &""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T_swap" "', argument " "2"" of type '" "std::map< std::string,double > &""'"); 
   }
   if (!argp2) {
-    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t_swap" "', argument " "2"" of type '" "std::map< std::string,double > &""'"); 
+    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T_swap" "', argument " "2"" of type '" "std::map< std::string,double > &""'"); 
   }
   arg2 = reinterpret_cast< std::map< std::string,double > * >(argp2);
   (arg1)->swap(*arg2);
@@ -22009,7 +22009,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_begin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_begin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -22022,7 +22022,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_begin(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_begin" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_begin" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (arg1)->begin();
@@ -22034,7 +22034,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_end(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_end(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -22047,7 +22047,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_end(PyObject *self, PyObject *arg
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_end" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_end" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (arg1)->end();
@@ -22059,7 +22059,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_rbegin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_rbegin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -22072,7 +22072,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_rbegin(PyObject *self, PyObject *
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_rbegin" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_rbegin" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (arg1)->rbegin();
@@ -22084,7 +22084,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_rend(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_rend(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -22097,7 +22097,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_rend(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_rend" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_rend" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (arg1)->rend();
@@ -22109,7 +22109,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_clear(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_clear(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -22121,7 +22121,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_clear(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_clear" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_clear" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   (arg1)->clear();
@@ -22132,7 +22132,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_get_allocator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_get_allocator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -22145,7 +22145,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_get_allocator(PyObject *self, PyO
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_get_allocator" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_get_allocator" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = ((std::map< std::string,double > const *)arg1)->get_allocator();
@@ -22156,7 +22156,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::key_type *arg2 = 0 ;
@@ -22169,17 +22169,17 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_erase__SWIG_0(PyObject *self, Py_
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_erase" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_erase" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t_erase" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T_erase" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t_erase" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T_erase" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -22193,7 +22193,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_count(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_count(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::key_type *arg2 = 0 ;
@@ -22204,20 +22204,20 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_count(PyObject *self, PyObject *a
   std::map< std::string,double >::size_type result;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "map_string_double_t_count", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "map_string_double_T_count", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_count" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_count" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t_count" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T_count" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t_count" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T_count" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -22231,7 +22231,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::iterator arg2 ;
@@ -22244,18 +22244,18 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_erase__SWIG_1(PyObject *self, Py_
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_erase" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_erase" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_t_erase" "', argument " "2"" of type '" "std::map< std::string,double >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_T_erase" "', argument " "2"" of type '" "std::map< std::string,double >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::map< std::string,double >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::map< std::string,double >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_t_erase" "', argument " "2"" of type '" "std::map< std::string,double >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_T_erase" "', argument " "2"" of type '" "std::map< std::string,double >::iterator""'");
     }
   }
   std_map_Sl_std_string_Sc_double_Sg__erase__SWIG_1(arg1,SWIG_STD_MOVE(arg2));
@@ -22266,7 +22266,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_erase__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_erase__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::iterator arg2 ;
@@ -22282,29 +22282,29 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_erase__SWIG_2(PyObject *self, Py_
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_erase" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_erase" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_t_erase" "', argument " "2"" of type '" "std::map< std::string,double >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_T_erase" "', argument " "2"" of type '" "std::map< std::string,double >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::map< std::string,double >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::map< std::string,double >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_t_erase" "', argument " "2"" of type '" "std::map< std::string,double >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_T_erase" "', argument " "2"" of type '" "std::map< std::string,double >::iterator""'");
     }
   }
   res3 = SWIG_ConvertPtr(swig_obj[2], SWIG_as_voidptrptr(&iter3), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res3) || !iter3) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_t_erase" "', argument " "3"" of type '" "std::map< std::string,double >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_T_erase" "', argument " "3"" of type '" "std::map< std::string,double >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::map< std::string,double >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::map< std::string,double >::iterator > *>(iter3);
     if (iter_t) {
       arg3 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_t_erase" "', argument " "3"" of type '" "std::map< std::string,double >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_T_erase" "', argument " "3"" of type '" "std::map< std::string,double >::iterator""'");
     }
   }
   std_map_Sl_std_string_Sc_double_Sg__erase__SWIG_2(arg1,SWIG_STD_MOVE(arg2),SWIG_STD_MOVE(arg3));
@@ -22315,13 +22315,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_erase(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_erase(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "map_string_double_t_erase", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "map_string_double_T_erase", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -22332,7 +22332,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_erase(PyObject *self, PyObject *a
       int res = SWIG_ConvertPtr(argv[1], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
       _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::map< std::string,double >::iterator > *>(iter) != 0));
       if (_v) {
-        return _wrap_map_string_double_t_erase__SWIG_1(self, argc, argv);
+        return _wrap_map_string_double_T_erase__SWIG_1(self, argc, argv);
       }
     }
   }
@@ -22344,7 +22344,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_erase(PyObject *self, PyObject *a
       int res = SWIG_AsPtr_std_string(argv[1], (std::string**)(0));
       _v = SWIG_CheckState(res);
       if (_v) {
-        return _wrap_map_string_double_t_erase__SWIG_0(self, argc, argv);
+        return _wrap_map_string_double_T_erase__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -22361,14 +22361,14 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_erase(PyObject *self, PyObject *a
         int res = SWIG_ConvertPtr(argv[2], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
         _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::map< std::string,double >::iterator > *>(iter) != 0));
         if (_v) {
-          return _wrap_map_string_double_t_erase__SWIG_2(self, argc, argv);
+          return _wrap_map_string_double_T_erase__SWIG_2(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'map_string_double_t_erase'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'map_string_double_T_erase'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::map< std::string,double >::erase(std::map< std::string,double >::key_type const &)\n"
     "    std::map< std::string,double >::erase(std::map< std::string,double >::iterator)\n"
@@ -22377,7 +22377,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_find(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_find(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::key_type *arg2 = 0 ;
@@ -22388,20 +22388,20 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_find(PyObject *self, PyObject *ar
   std::map< std::string,double >::iterator result;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "map_string_double_t_find", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "map_string_double_T_find", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_find" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_find" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t_find" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T_find" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t_find" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T_find" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -22416,7 +22416,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_lower_bound(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_lower_bound(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::key_type *arg2 = 0 ;
@@ -22427,20 +22427,20 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_lower_bound(PyObject *self, PyObj
   std::map< std::string,double >::iterator result;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "map_string_double_t_lower_bound", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "map_string_double_T_lower_bound", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_lower_bound" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_lower_bound" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t_lower_bound" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T_lower_bound" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t_lower_bound" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T_lower_bound" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -22455,7 +22455,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_upper_bound(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_upper_bound(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::key_type *arg2 = 0 ;
@@ -22466,20 +22466,20 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_upper_bound(PyObject *self, PyObj
   std::map< std::string,double >::iterator result;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "map_string_double_t_upper_bound", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "map_string_double_T_upper_bound", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_upper_bound" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_upper_bound" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t_upper_bound" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T_upper_bound" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t_upper_bound" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T_upper_bound" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -22494,7 +22494,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_delete_map_string_double_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_delete_map_string_double_T(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -22506,7 +22506,7 @@ SWIGINTERN PyObject *_wrap_delete_map_string_double_t(PyObject *self, PyObject *
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, SWIG_POINTER_DISOWN |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_map_string_double_t" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_map_string_double_T" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
@@ -22527,18 +22527,18 @@ fail:
 }
 
 
-SWIGINTERN PyObject *map_string_double_t_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *map_string_double_T_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   PyObject *obj;
   if (!SWIG_Python_UnpackTuple(args, "swigregister", 1, 1, &obj)) return NULL;
   SWIG_TypeNewClientData(SWIGTYPE_p_std__mapT_std__string_double_t, SWIG_NewClientData(obj));
   return SWIG_Py_Void();
 }
 
-SWIGINTERN PyObject *map_string_double_t_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *map_string_double_T_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   return SWIG_Python_InitShadowInstance(args);
 }
 
-SWIGINTERN PyObject *_wrap_new_pvacuum_double_t__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
+SWIGINTERN PyObject *_wrap_new_pvacuum_double_T__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
   PyObject *resultobj = 0;
   std::pair< double,double > *result = 0 ;
   
@@ -22552,7 +22552,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_pvacuum_double_t__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_pvacuum_double_T__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   double arg1 ;
   double arg2 ;
@@ -22566,12 +22566,12 @@ SWIGINTERN PyObject *_wrap_new_pvacuum_double_t__SWIG_1(PyObject *self, Py_ssize
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   ecode1 = SWIG_AsVal_double(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_pvacuum_double_t" "', argument " "1"" of type '" "double""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_pvacuum_double_T" "', argument " "1"" of type '" "double""'");
   } 
   arg1 = static_cast< double >(val1);
   ecode2 = SWIG_AsVal_double(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "new_pvacuum_double_t" "', argument " "2"" of type '" "double""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "new_pvacuum_double_T" "', argument " "2"" of type '" "double""'");
   } 
   arg2 = static_cast< double >(val2);
   result = (std::pair< double,double > *)new std::pair< double,double >(arg1,arg2);
@@ -22582,7 +22582,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_pvacuum_double_t__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_pvacuum_double_T__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::pair< double,double > *arg1 = 0 ;
   int res1 = SWIG_OLDOBJ ;
@@ -22594,10 +22594,10 @@ SWIGINTERN PyObject *_wrap_new_pvacuum_double_t__SWIG_2(PyObject *self, Py_ssize
     std::pair< double,double > *ptr = (std::pair< double,double > *)0;
     res1 = swig::asptr(swig_obj[0], &ptr);
     if (!SWIG_IsOK(res1)) {
-      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_pvacuum_double_t" "', argument " "1"" of type '" "std::pair< double,double > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_pvacuum_double_T" "', argument " "1"" of type '" "std::pair< double,double > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_pvacuum_double_t" "', argument " "1"" of type '" "std::pair< double,double > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_pvacuum_double_T" "', argument " "1"" of type '" "std::pair< double,double > const &""'"); 
     }
     arg1 = ptr;
   }
@@ -22611,23 +22611,23 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_pvacuum_double_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_new_pvacuum_double_T(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "new_pvacuum_double_t", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "new_pvacuum_double_T", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 0) {
-    return _wrap_new_pvacuum_double_t__SWIG_0(self, argc, argv);
+    return _wrap_new_pvacuum_double_T__SWIG_0(self, argc, argv);
   }
   if (argc == 1) {
     int _v = 0;
     int res = swig::asptr(argv[0], (std::pair< double,double >**)(0));
     _v = SWIG_CheckState(res);
     if (_v) {
-      return _wrap_new_pvacuum_double_t__SWIG_2(self, argc, argv);
+      return _wrap_new_pvacuum_double_T__SWIG_2(self, argc, argv);
     }
   }
   if (argc == 2) {
@@ -22642,13 +22642,13 @@ SWIGINTERN PyObject *_wrap_new_pvacuum_double_t(PyObject *self, PyObject *args)
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_new_pvacuum_double_t__SWIG_1(self, argc, argv);
+        return _wrap_new_pvacuum_double_T__SWIG_1(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_pvacuum_double_t'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_pvacuum_double_T'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::pair< double,double >::pair()\n"
     "    std::pair< double,double >::pair(double,double)\n"
@@ -22657,7 +22657,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_pvacuum_double_t_first_set(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_pvacuum_double_T_first_set(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::pair< double,double > *arg1 = (std::pair< double,double > *) 0 ;
   double arg2 ;
@@ -22668,15 +22668,15 @@ SWIGINTERN PyObject *_wrap_pvacuum_double_t_first_set(PyObject *self, PyObject *
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "pvacuum_double_t_first_set", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "pvacuum_double_T_first_set", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__pairT_double_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "pvacuum_double_t_first_set" "', argument " "1"" of type '" "std::pair< double,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "pvacuum_double_T_first_set" "', argument " "1"" of type '" "std::pair< double,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::pair< double,double > * >(argp1);
   ecode2 = SWIG_AsVal_double(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "pvacuum_double_t_first_set" "', argument " "2"" of type '" "double""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "pvacuum_double_T_first_set" "', argument " "2"" of type '" "double""'");
   } 
   arg2 = static_cast< double >(val2);
   if (arg1) (arg1)->first = arg2;
@@ -22687,7 +22687,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_pvacuum_double_t_first_get(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_pvacuum_double_T_first_get(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::pair< double,double > *arg1 = (std::pair< double,double > *) 0 ;
   void *argp1 = 0 ;
@@ -22700,7 +22700,7 @@ SWIGINTERN PyObject *_wrap_pvacuum_double_t_first_get(PyObject *self, PyObject *
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__pairT_double_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "pvacuum_double_t_first_get" "', argument " "1"" of type '" "std::pair< double,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "pvacuum_double_T_first_get" "', argument " "1"" of type '" "std::pair< double,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::pair< double,double > * >(argp1);
   result = (double) ((arg1)->first);
@@ -22711,7 +22711,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_pvacuum_double_t_second_set(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_pvacuum_double_T_second_set(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::pair< double,double > *arg1 = (std::pair< double,double > *) 0 ;
   double arg2 ;
@@ -22722,15 +22722,15 @@ SWIGINTERN PyObject *_wrap_pvacuum_double_t_second_set(PyObject *self, PyObject
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "pvacuum_double_t_second_set", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "pvacuum_double_T_second_set", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__pairT_double_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "pvacuum_double_t_second_set" "', argument " "1"" of type '" "std::pair< double,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "pvacuum_double_T_second_set" "', argument " "1"" of type '" "std::pair< double,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::pair< double,double > * >(argp1);
   ecode2 = SWIG_AsVal_double(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "pvacuum_double_t_second_set" "', argument " "2"" of type '" "double""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "pvacuum_double_T_second_set" "', argument " "2"" of type '" "double""'");
   } 
   arg2 = static_cast< double >(val2);
   if (arg1) (arg1)->second = arg2;
@@ -22741,7 +22741,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_pvacuum_double_t_second_get(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_pvacuum_double_T_second_get(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::pair< double,double > *arg1 = (std::pair< double,double > *) 0 ;
   void *argp1 = 0 ;
@@ -22754,7 +22754,7 @@ SWIGINTERN PyObject *_wrap_pvacuum_double_t_second_get(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__pairT_double_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "pvacuum_double_t_second_get" "', argument " "1"" of type '" "std::pair< double,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "pvacuum_double_T_second_get" "', argument " "1"" of type '" "std::pair< double,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::pair< double,double > * >(argp1);
   result = (double) ((arg1)->second);
@@ -22765,7 +22765,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_delete_pvacuum_double_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_delete_pvacuum_double_T(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::pair< double,double > *arg1 = (std::pair< double,double > *) 0 ;
   void *argp1 = 0 ;
@@ -22777,7 +22777,7 @@ SWIGINTERN PyObject *_wrap_delete_pvacuum_double_t(PyObject *self, PyObject *arg
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__pairT_double_double_t, SWIG_POINTER_DISOWN |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_pvacuum_double_t" "', argument " "1"" of type '" "std::pair< double,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_pvacuum_double_T" "', argument " "1"" of type '" "std::pair< double,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::pair< double,double > * >(argp1);
   {
@@ -22798,18 +22798,18 @@ fail:
 }
 
 
-SWIGINTERN PyObject *pvacuum_double_t_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *pvacuum_double_T_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   PyObject *obj;
   if (!SWIG_Python_UnpackTuple(args, "swigregister", 1, 1, &obj)) return NULL;
   SWIG_TypeNewClientData(SWIGTYPE_p_std__pairT_double_double_t, SWIG_NewClientData(obj));
   return SWIG_Py_Void();
 }
 
-SWIGINTERN PyObject *pvacuum_double_t_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *pvacuum_double_T_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   return SWIG_Python_InitShadowInstance(args);
 }
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_iterator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_iterator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   PyObject **arg2 = (PyObject **) 0 ;
@@ -22824,7 +22824,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_iterator(PyObject *self, PyOb
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_iterator" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_iterator" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = (swig::SwigPyIterator *)std_vector_Sl_std_pair_Sl_double_Sc_double_Sg__Sg__iterator(arg1,arg2);
@@ -22835,7 +22835,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___nonzero__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___nonzero__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -22848,7 +22848,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___nonzero__(PyObject *self, P
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___nonzero__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___nonzero__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = (bool)std_vector_Sl_std_pair_Sl_double_Sc_double_Sg__Sg____nonzero__((std::vector< std::pair< double,double > > const *)arg1);
@@ -22859,7 +22859,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___bool__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___bool__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -22872,7 +22872,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___bool__(PyObject *self, PyOb
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___bool__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___bool__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = (bool)std_vector_Sl_std_pair_Sl_double_Sc_double_Sg__Sg____bool__((std::vector< std::pair< double,double > > const *)arg1);
@@ -22883,7 +22883,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___len__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___len__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -22896,7 +22896,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___len__(PyObject *self, PyObj
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___len__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___len__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = std_vector_Sl_std_pair_Sl_double_Sc_double_Sg__Sg____len__((std::vector< std::pair< double,double > > const *)arg1);
@@ -22907,7 +22907,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___getslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___getslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::difference_type arg2 ;
@@ -22922,20 +22922,20 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___getslice__(PyObject *self,
   std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > *result = 0 ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t___getslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T___getslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___getslice__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___getslice__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_t___getslice__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_T___getslice__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::pair< double,double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_pvacuum_double_t___getslice__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_pvacuum_double_T___getslice__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::pair< double,double > >::difference_type >(val3);
   try {
@@ -22952,7 +22952,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::difference_type arg2 ;
@@ -22968,17 +22968,17 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setslice____SWIG_0(PyObject
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___setslice__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___setslice__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_t___setslice__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_T___setslice__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::pair< double,double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_pvacuum_double_t___setslice__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_pvacuum_double_T___setslice__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::pair< double,double > >::difference_type >(val3);
   try {
@@ -22995,7 +22995,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::difference_type arg2 ;
@@ -23013,27 +23013,27 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setslice____SWIG_1(PyObject
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___setslice__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___setslice__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_t___setslice__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_T___setslice__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::pair< double,double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_pvacuum_double_t___setslice__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_pvacuum_double_T___setslice__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::pair< double,double > >::difference_type >(val3);
   {
     std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > *ptr = (std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > *)0;
     res4 = swig::asptr(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_pvacuum_double_t___setslice__" "', argument " "4"" of type '" "std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_pvacuum_double_T___setslice__" "', argument " "4"" of type '" "std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_t___setslice__" "', argument " "4"" of type '" "std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_T___setslice__" "', argument " "4"" of type '" "std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > const &""'"); 
     }
     arg4 = ptr;
   }
@@ -23053,13 +23053,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___setslice__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t___setslice__", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T___setslice__", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -23076,7 +23076,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setslice__(PyObject *self,
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_pvacuum_double_t___setslice____SWIG_0(self, argc, argv);
+          return _wrap_vector_pvacuum_double_T___setslice____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -23099,7 +23099,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setslice__(PyObject *self,
           int res = swig::asptr(argv[3], (std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > >**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vector_pvacuum_double_t___setslice____SWIG_1(self, argc, argv);
+            return _wrap_vector_pvacuum_double_T___setslice____SWIG_1(self, argc, argv);
           }
         }
       }
@@ -23107,7 +23107,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setslice__(PyObject *self,
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_t___setslice__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_T___setslice__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::pair< double,double > >::__setslice__(std::vector< std::pair< double,double > >::difference_type,std::vector< std::pair< double,double > >::difference_type)\n"
     "    std::vector< std::pair< double,double > >::__setslice__(std::vector< std::pair< double,double > >::difference_type,std::vector< std::pair< double,double > >::difference_type,std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > const &)\n");
@@ -23115,7 +23115,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___delslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___delslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::difference_type arg2 ;
@@ -23129,20 +23129,20 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___delslice__(PyObject *self,
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t___delslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T___delslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___delslice__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___delslice__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_t___delslice__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_T___delslice__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::pair< double,double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_pvacuum_double_t___delslice__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_pvacuum_double_T___delslice__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::pair< double,double > >::difference_type >(val3);
   try {
@@ -23159,7 +23159,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::difference_type arg2 ;
@@ -23172,12 +23172,12 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___delitem____SWIG_0(PyObject
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___delitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___delitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_t___delitem__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_T___delitem__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::pair< double,double > >::difference_type >(val2);
   try {
@@ -23194,7 +23194,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -23206,12 +23206,12 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___getitem____SWIG_0(PyObject
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___getitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___getitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -23229,7 +23229,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -23242,12 +23242,12 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setitem____SWIG_0(PyObject
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___setitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___setitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -23255,10 +23255,10 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setitem____SWIG_0(PyObject
     std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > *ptr = (std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_pvacuum_double_t___setitem__" "', argument " "3"" of type '" "std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_pvacuum_double_T___setitem__" "', argument " "3"" of type '" "std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_t___setitem__" "', argument " "3"" of type '" "std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_T___setitem__" "', argument " "3"" of type '" "std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > const &""'"); 
     }
     arg3 = ptr;
   }
@@ -23278,7 +23278,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -23289,12 +23289,12 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setitem____SWIG_1(PyObject
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___setitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___setitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -23312,7 +23312,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -23323,12 +23323,12 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___delitem____SWIG_1(PyObject
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___delitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___delitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -23346,13 +23346,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___delitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___delitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t___delitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T___delitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -23363,7 +23363,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___delitem__(PyObject *self, P
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_pvacuum_double_t___delitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_pvacuum_double_T___delitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -23377,13 +23377,13 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___delitem__(PyObject *self, P
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_pvacuum_double_t___delitem____SWIG_0(self, argc, argv);
+        return _wrap_vector_pvacuum_double_T___delitem____SWIG_0(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_t___delitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_T___delitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::pair< double,double > >::__delitem__(std::vector< std::pair< double,double > >::difference_type)\n"
     "    std::vector< std::pair< double,double > >::__delitem__(SWIGPY_SLICEOBJECT *)\n");
@@ -23391,7 +23391,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::difference_type arg2 ;
@@ -23405,12 +23405,12 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___getitem____SWIG_1(PyObject
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___getitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___getitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_t___getitem__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_T___getitem__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::pair< double,double > >::difference_type >(val2);
   try {
@@ -23426,13 +23426,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___getitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___getitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t___getitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T___getitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -23443,7 +23443,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___getitem__(PyObject *self, P
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_pvacuum_double_t___getitem____SWIG_0(self, argc, argv);
+        return _wrap_vector_pvacuum_double_T___getitem____SWIG_0(self, argc, argv);
       }
     }
   }
@@ -23457,13 +23457,13 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___getitem__(PyObject *self, P
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_pvacuum_double_t___getitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_pvacuum_double_T___getitem____SWIG_1(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_t___getitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_T___getitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::pair< double,double > >::__getitem__(SWIGPY_SLICEOBJECT *)\n"
     "    std::vector< std::pair< double,double > >::__getitem__(std::vector< std::pair< double,double > >::difference_type) const\n");
@@ -23471,7 +23471,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::difference_type arg2 ;
@@ -23486,22 +23486,22 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setitem____SWIG_2(PyObject
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___setitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___setitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_t___setitem__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_T___setitem__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::pair< double,double > >::difference_type >(val2);
   {
     std::pair< double,double > *ptr = (std::pair< double,double > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_pvacuum_double_t___setitem__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_pvacuum_double_T___setitem__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_t___setitem__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_T___setitem__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -23519,13 +23519,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___setitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t___setitem__", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T___setitem__", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -23536,7 +23536,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setitem__(PyObject *self, P
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_pvacuum_double_t___setitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_pvacuum_double_T___setitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -23552,7 +23552,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setitem__(PyObject *self, P
         int res = swig::asptr(argv[2], (std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vector_pvacuum_double_t___setitem____SWIG_0(self, argc, argv);
+          return _wrap_vector_pvacuum_double_T___setitem____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -23570,14 +23570,14 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setitem__(PyObject *self, P
         int res = swig::asptr(argv[2], (std::pair< double,double >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vector_pvacuum_double_t___setitem____SWIG_2(self, argc, argv);
+          return _wrap_vector_pvacuum_double_T___setitem____SWIG_2(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_t___setitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_T___setitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::pair< double,double > >::__setitem__(SWIGPY_SLICEOBJECT *,std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > const &)\n"
     "    std::vector< std::pair< double,double > >::__setitem__(SWIGPY_SLICEOBJECT *)\n"
@@ -23586,7 +23586,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_pop(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_pop(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -23599,7 +23599,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_pop(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_pop" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_pop" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   try {
@@ -23614,7 +23614,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_append(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_append(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::value_type *arg2 = 0 ;
@@ -23624,20 +23624,20 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_append(PyObject *self, PyObje
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t_append", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T_append", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_append" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_append" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   {
     std::pair< double,double > *ptr = (std::pair< double,double > *)0;
     res2 = swig::asptr(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_pvacuum_double_t_append" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_pvacuum_double_T_append" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_t_append" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_T_append" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -23651,7 +23651,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_t__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
+SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_T__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *result = 0 ;
   
@@ -23665,7 +23665,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_t__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_T__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = 0 ;
   int res1 = SWIG_OLDOBJ ;
@@ -23677,10 +23677,10 @@ SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_t__SWIG_1(PyObject *self, P
     std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > *ptr = (std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > *)0;
     res1 = swig::asptr(swig_obj[0], &ptr);
     if (!SWIG_IsOK(res1)) {
-      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vector_pvacuum_double_t" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vector_pvacuum_double_T" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_pvacuum_double_t" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_pvacuum_double_T" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const &""'"); 
     }
     arg1 = ptr;
   }
@@ -23694,7 +23694,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_empty(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_empty(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -23707,7 +23707,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_empty(PyObject *self, PyObjec
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_empty" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_empty" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = (bool)((std::vector< std::pair< double,double > > const *)arg1)->empty();
@@ -23718,7 +23718,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_size(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_size(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -23731,7 +23731,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_size(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_size" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_size" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = ((std::vector< std::pair< double,double > > const *)arg1)->size();
@@ -23742,7 +23742,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_swap(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_swap(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > > *arg2 = 0 ;
@@ -23753,18 +23753,18 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_swap(PyObject *self, PyObject
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t_swap", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T_swap", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_swap" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_swap" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], &argp2, SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t,  0 );
   if (!SWIG_IsOK(res2)) {
-    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_pvacuum_double_t_swap" "', argument " "2"" of type '" "std::vector< std::pair< double,double > > &""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_pvacuum_double_T_swap" "', argument " "2"" of type '" "std::vector< std::pair< double,double > > &""'"); 
   }
   if (!argp2) {
-    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_t_swap" "', argument " "2"" of type '" "std::vector< std::pair< double,double > > &""'"); 
+    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_T_swap" "', argument " "2"" of type '" "std::vector< std::pair< double,double > > &""'"); 
   }
   arg2 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp2);
   (arg1)->swap(*arg2);
@@ -23775,7 +23775,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_begin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_begin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -23788,7 +23788,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_begin(PyObject *self, PyObjec
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_begin" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_begin" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = (arg1)->begin();
@@ -23800,7 +23800,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_end(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_end(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -23813,7 +23813,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_end(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_end" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_end" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = (arg1)->end();
@@ -23825,7 +23825,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_rbegin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_rbegin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -23838,7 +23838,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_rbegin(PyObject *self, PyObje
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_rbegin" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_rbegin" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = (arg1)->rbegin();
@@ -23850,7 +23850,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_rend(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_rend(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -23863,7 +23863,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_rend(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_rend" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_rend" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = (arg1)->rend();
@@ -23875,7 +23875,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_clear(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_clear(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -23887,7 +23887,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_clear(PyObject *self, PyObjec
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_clear" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_clear" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   (arg1)->clear();
@@ -23898,7 +23898,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_get_allocator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_get_allocator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -23911,7 +23911,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_get_allocator(PyObject *self,
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_get_allocator" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_get_allocator" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = ((std::vector< std::pair< double,double > > const *)arg1)->get_allocator();
@@ -23922,7 +23922,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_t__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_T__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > >::size_type arg1 ;
   size_t val1 ;
@@ -23933,7 +23933,7 @@ SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_t__SWIG_2(PyObject *self, P
   if ((nobjs < 1) || (nobjs > 1)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_pvacuum_double_t" "', argument " "1"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_pvacuum_double_T" "', argument " "1"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
   } 
   arg1 = static_cast< std::vector< std::pair< double,double > >::size_type >(val1);
   result = (std::vector< std::pair< double,double > > *)new std::vector< std::pair< double,double > >(arg1);
@@ -23944,7 +23944,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_pop_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_pop_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -23956,7 +23956,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_pop_back(PyObject *self, PyOb
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_pop_back" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_pop_back" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   (arg1)->pop_back();
@@ -23967,7 +23967,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::size_type arg2 ;
@@ -23980,12 +23980,12 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_resize__SWIG_0(PyObject *self
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_resize" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_resize" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_t_resize" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_T_resize" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::pair< double,double > >::size_type >(val2);
   (arg1)->resize(arg2);
@@ -23996,7 +23996,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::iterator arg2 ;
@@ -24010,18 +24010,18 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_erase__SWIG_0(PyObject *self,
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_erase" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_erase" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t_erase" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T_erase" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t_erase" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T_erase" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
     }
   }
   result = std_vector_Sl_std_pair_Sl_double_Sc_double_Sg__Sg__erase__SWIG_0(arg1,SWIG_STD_MOVE(arg2));
@@ -24033,7 +24033,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::iterator arg2 ;
@@ -24050,29 +24050,29 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_erase__SWIG_1(PyObject *self,
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_erase" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_erase" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t_erase" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T_erase" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t_erase" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T_erase" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
     }
   }
   res3 = SWIG_ConvertPtr(swig_obj[2], SWIG_as_voidptrptr(&iter3), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res3) || !iter3) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t_erase" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T_erase" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *>(iter3);
     if (iter_t) {
       arg3 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t_erase" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T_erase" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
     }
   }
   result = std_vector_Sl_std_pair_Sl_double_Sc_double_Sg__Sg__erase__SWIG_1(arg1,SWIG_STD_MOVE(arg2),SWIG_STD_MOVE(arg3));
@@ -24084,13 +24084,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_erase(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_erase(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t_erase", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T_erase", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -24101,7 +24101,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_erase(PyObject *self, PyObjec
       int res = SWIG_ConvertPtr(argv[1], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
       _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *>(iter) != 0));
       if (_v) {
-        return _wrap_vector_pvacuum_double_t_erase__SWIG_0(self, argc, argv);
+        return _wrap_vector_pvacuum_double_T_erase__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -24118,14 +24118,14 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_erase(PyObject *self, PyObjec
         int res = SWIG_ConvertPtr(argv[2], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
         _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *>(iter) != 0));
         if (_v) {
-          return _wrap_vector_pvacuum_double_t_erase__SWIG_1(self, argc, argv);
+          return _wrap_vector_pvacuum_double_T_erase__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_t_erase'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_T_erase'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::pair< double,double > >::erase(std::vector< std::pair< double,double > >::iterator)\n"
     "    std::vector< std::pair< double,double > >::erase(std::vector< std::pair< double,double > >::iterator,std::vector< std::pair< double,double > >::iterator)\n");
@@ -24133,7 +24133,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_t__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_T__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > >::size_type arg1 ;
   std::vector< std::pair< double,double > >::value_type *arg2 = 0 ;
@@ -24146,17 +24146,17 @@ SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_t__SWIG_3(PyObject *self, P
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_pvacuum_double_t" "', argument " "1"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_pvacuum_double_T" "', argument " "1"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
   } 
   arg1 = static_cast< std::vector< std::pair< double,double > >::size_type >(val1);
   {
     std::pair< double,double > *ptr = (std::pair< double,double > *)0;
     res2 = swig::asptr(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "new_vector_pvacuum_double_t" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "new_vector_pvacuum_double_T" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_pvacuum_double_t" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_pvacuum_double_T" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -24170,16 +24170,16 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_T(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vector_pvacuum_double_t", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vector_pvacuum_double_T", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 0) {
-    return _wrap_new_vector_pvacuum_double_t__SWIG_0(self, argc, argv);
+    return _wrap_new_vector_pvacuum_double_T__SWIG_0(self, argc, argv);
   }
   if (argc == 1) {
     int _v = 0;
@@ -24188,7 +24188,7 @@ SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_t(PyObject *self, PyObject
       _v = SWIG_CheckState(res);
     }
     if (_v) {
-      return _wrap_new_vector_pvacuum_double_t__SWIG_2(self, argc, argv);
+      return _wrap_new_vector_pvacuum_double_T__SWIG_2(self, argc, argv);
     }
   }
   if (argc == 1) {
@@ -24196,7 +24196,7 @@ SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_t(PyObject *self, PyObject
     int res = swig::asptr(argv[0], (std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > >**)(0));
     _v = SWIG_CheckState(res);
     if (_v) {
-      return _wrap_new_vector_pvacuum_double_t__SWIG_1(self, argc, argv);
+      return _wrap_new_vector_pvacuum_double_T__SWIG_1(self, argc, argv);
     }
   }
   if (argc == 2) {
@@ -24209,13 +24209,13 @@ SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_t(PyObject *self, PyObject
       int res = swig::asptr(argv[1], (std::pair< double,double >**)(0));
       _v = SWIG_CheckState(res);
       if (_v) {
-        return _wrap_new_vector_pvacuum_double_t__SWIG_3(self, argc, argv);
+        return _wrap_new_vector_pvacuum_double_T__SWIG_3(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vector_pvacuum_double_t'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vector_pvacuum_double_T'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::pair< double,double > >::vector()\n"
     "    std::vector< std::pair< double,double > >::vector(std::vector< std::pair< double,double > > const &)\n"
@@ -24225,7 +24225,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_push_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_push_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::value_type *arg2 = 0 ;
@@ -24235,20 +24235,20 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_push_back(PyObject *self, PyO
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t_push_back", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T_push_back", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_push_back" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_push_back" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   {
     std::pair< double,double > *ptr = (std::pair< double,double > *)0;
     res2 = swig::asptr(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_pvacuum_double_t_push_back" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_pvacuum_double_T_push_back" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_t_push_back" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_T_push_back" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -24262,7 +24262,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_front(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_front(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -24275,7 +24275,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_front(PyObject *self, PyObjec
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_front" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_front" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = (std::vector< std::pair< double,double > >::value_type *) &((std::vector< std::pair< double,double > > const *)arg1)->front();
@@ -24287,7 +24287,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -24300,7 +24300,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_back(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_back" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_back" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = (std::vector< std::pair< double,double > >::value_type *) &((std::vector< std::pair< double,double > > const *)arg1)->back();
@@ -24312,7 +24312,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_assign(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_assign(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::size_type arg2 ;
@@ -24325,25 +24325,25 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_assign(PyObject *self, PyObje
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t_assign", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T_assign", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_assign" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_assign" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_t_assign" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_T_assign" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::pair< double,double > >::size_type >(val2);
   {
     std::pair< double,double > *ptr = (std::pair< double,double > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_pvacuum_double_t_assign" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_pvacuum_double_T_assign" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_t_assign" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_T_assign" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -24357,7 +24357,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::size_type arg2 ;
@@ -24372,22 +24372,22 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_resize__SWIG_1(PyObject *self
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_resize" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_resize" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_t_resize" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_T_resize" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::pair< double,double > >::size_type >(val2);
   {
     std::pair< double,double > *ptr = (std::pair< double,double > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_pvacuum_double_t_resize" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_pvacuum_double_T_resize" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_t_resize" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_T_resize" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -24401,13 +24401,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_resize(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_resize(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t_resize", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T_resize", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -24419,7 +24419,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_resize(PyObject *self, PyObje
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_pvacuum_double_t_resize__SWIG_0(self, argc, argv);
+        return _wrap_vector_pvacuum_double_T_resize__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -24436,14 +24436,14 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_resize(PyObject *self, PyObje
         int res = swig::asptr(argv[2], (std::pair< double,double >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vector_pvacuum_double_t_resize__SWIG_1(self, argc, argv);
+          return _wrap_vector_pvacuum_double_T_resize__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_t_resize'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_T_resize'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::pair< double,double > >::resize(std::vector< std::pair< double,double > >::size_type)\n"
     "    std::vector< std::pair< double,double > >::resize(std::vector< std::pair< double,double > >::size_type,std::vector< std::pair< double,double > >::value_type const &)\n");
@@ -24451,7 +24451,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::iterator arg2 ;
@@ -24467,28 +24467,28 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_insert__SWIG_0(PyObject *self
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_insert" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_insert" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t_insert" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T_insert" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t_insert" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T_insert" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
     }
   }
   {
     std::pair< double,double > *ptr = (std::pair< double,double > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_pvacuum_double_t_insert" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_pvacuum_double_T_insert" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_t_insert" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_T_insert" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -24503,7 +24503,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::iterator arg2 ;
@@ -24521,33 +24521,33 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_insert__SWIG_1(PyObject *self
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_insert" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_insert" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t_insert" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T_insert" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t_insert" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T_insert" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_size_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_pvacuum_double_t_insert" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_pvacuum_double_T_insert" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
   } 
   arg3 = static_cast< std::vector< std::pair< double,double > >::size_type >(val3);
   {
     std::pair< double,double > *ptr = (std::pair< double,double > *)0;
     res4 = swig::asptr(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_pvacuum_double_t_insert" "', argument " "4"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_pvacuum_double_T_insert" "', argument " "4"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_t_insert" "', argument " "4"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_T_insert" "', argument " "4"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     arg4 = ptr;
   }
@@ -24561,13 +24561,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_insert(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_insert(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t_insert", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T_insert", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -24581,7 +24581,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_insert(PyObject *self, PyObje
         int res = swig::asptr(argv[2], (std::pair< double,double >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vector_pvacuum_double_t_insert__SWIG_0(self, argc, argv);
+          return _wrap_vector_pvacuum_double_T_insert__SWIG_0(self, argc, argv);
         }
       }
     }
@@ -24603,7 +24603,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_insert(PyObject *self, PyObje
           int res = swig::asptr(argv[3], (std::pair< double,double >**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vector_pvacuum_double_t_insert__SWIG_1(self, argc, argv);
+            return _wrap_vector_pvacuum_double_T_insert__SWIG_1(self, argc, argv);
           }
         }
       }
@@ -24611,7 +24611,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_insert(PyObject *self, PyObje
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_t_insert'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_T_insert'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::pair< double,double > >::insert(std::vector< std::pair< double,double > >::iterator,std::vector< std::pair< double,double > >::value_type const &)\n"
     "    std::vector< std::pair< double,double > >::insert(std::vector< std::pair< double,double > >::iterator,std::vector< std::pair< double,double > >::size_type,std::vector< std::pair< double,double > >::value_type const &)\n");
@@ -24619,7 +24619,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_reserve(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_reserve(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::size_type arg2 ;
@@ -24630,15 +24630,15 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_reserve(PyObject *self, PyObj
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t_reserve", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T_reserve", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_reserve" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_reserve" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_t_reserve" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_T_reserve" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::pair< double,double > >::size_type >(val2);
   (arg1)->reserve(arg2);
@@ -24649,7 +24649,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_capacity(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_capacity(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -24662,7 +24662,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_capacity(PyObject *self, PyOb
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_capacity" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_capacity" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = ((std::vector< std::pair< double,double > > const *)arg1)->capacity();
@@ -24673,7 +24673,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_delete_vector_pvacuum_double_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_delete_vector_pvacuum_double_T(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -24685,7 +24685,7 @@ SWIGINTERN PyObject *_wrap_delete_vector_pvacuum_double_t(PyObject *self, PyObje
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, SWIG_POINTER_DISOWN |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vector_pvacuum_double_t" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vector_pvacuum_double_T" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   {
@@ -24706,14 +24706,14 @@ fail:
 }
 
 
-SWIGINTERN PyObject *vector_pvacuum_double_t_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vector_pvacuum_double_T_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   PyObject *obj;
   if (!SWIG_Python_UnpackTuple(args, "swigregister", 1, 1, &obj)) return NULL;
   SWIG_TypeNewClientData(SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, SWIG_NewClientData(obj));
   return SWIG_Py_Void();
 }
 
-SWIGINTERN PyObject *vector_pvacuum_double_t_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vector_pvacuum_double_T_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   return SWIG_Python_InitShadowInstance(args);
 }
 
@@ -29796,10 +29796,11 @@ SWIGINTERN PyObject *_wrap_new_Datafield__SWIG_9(PyObject *self, Py_ssize_t nobj
   PyObject *resultobj = 0;
   std::string *arg1 = 0 ;
   std::string *arg2 = 0 ;
-  std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > *arg3 = 0 ;
+  double2d_t *arg3 = 0 ;
   int res1 = SWIG_OLDOBJ ;
   int res2 = SWIG_OLDOBJ ;
-  int res3 = SWIG_OLDOBJ ;
+  void *argp3 = 0 ;
+  int res3 = 0 ;
   Datafield *result = 0 ;
   
   (void)self;
@@ -29826,20 +29827,17 @@ SWIGINTERN PyObject *_wrap_new_Datafield__SWIG_9(PyObject *self, Py_ssize_t nobj
     }
     arg2 = ptr;
   }
-  {
-    std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > *ptr = (std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > *)0;
-    res3 = swig::asptr(swig_obj[2], &ptr);
-    if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "new_Datafield" "', argument " "3"" of type '" "std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > const &""'"); 
-    }
-    if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_Datafield" "', argument " "3"" of type '" "std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > const &""'"); 
-    }
-    arg3 = ptr;
+  res3 = SWIG_ConvertPtr(swig_obj[2], &argp3, SWIGTYPE_p_double2d_t,  0  | 0);
+  if (!SWIG_IsOK(res3)) {
+    SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "new_Datafield" "', argument " "3"" of type '" "double2d_t const &""'"); 
   }
+  if (!argp3) {
+    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_Datafield" "', argument " "3"" of type '" "double2d_t const &""'"); 
+  }
+  arg3 = reinterpret_cast< double2d_t * >(argp3);
   {
     try {
-      result = (Datafield *)new Datafield((std::string const &)*arg1,(std::string const &)*arg2,(std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > const &)*arg3);
+      result = (Datafield *)new Datafield((std::string const &)*arg1,(std::string const &)*arg2,(double2d_t const &)*arg3);
     } catch (const std::exception& ex) {
       // message shown in the Python interpreter
       const std::string msg {
@@ -29851,12 +29849,10 @@ SWIGINTERN PyObject *_wrap_new_Datafield__SWIG_9(PyObject *self, Py_ssize_t nobj
   resultobj = SWIG_NewPointerObj(SWIG_as_voidptr(result), SWIGTYPE_p_Datafield, SWIG_POINTER_NEW |  0 );
   if (SWIG_IsNewObj(res1)) delete arg1;
   if (SWIG_IsNewObj(res2)) delete arg2;
-  if (SWIG_IsNewObj(res3)) delete arg3;
   return resultobj;
 fail:
   if (SWIG_IsNewObj(res1)) delete arg1;
   if (SWIG_IsNewObj(res2)) delete arg2;
-  if (SWIG_IsNewObj(res3)) delete arg3;
   return NULL;
 }
 
@@ -30025,7 +30021,7 @@ SWIGINTERN PyObject *_wrap_new_Datafield(PyObject *self, PyObject *args) {
       int res = SWIG_AsPtr_std_string(argv[1], (std::string**)(0));
       _v = SWIG_CheckState(res);
       if (_v) {
-        int res = swig::asptr(argv[2], (std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > >**)(0));
+        int res = SWIG_ConvertPtr(argv[2], 0, SWIGTYPE_p_double2d_t, SWIG_POINTER_NO_NULL | 0);
         _v = SWIG_CheckState(res);
         if (_v) {
           return _wrap_new_Datafield__SWIG_9(self, argc, argv);
@@ -30067,7 +30063,7 @@ fail:
     "    Datafield::Datafield(std::vector< Scale const *,std::allocator< Scale const * > > const &,std::vector< double,std::allocator< double > > const &,std::vector< double,std::allocator< double > > const &)\n"
     "    Datafield::Datafield(std::vector< Scale const *,std::allocator< Scale const * > > const &,std::vector< double,std::allocator< double > > const &)\n"
     "    Datafield::Datafield(std::vector< Scale const *,std::allocator< Scale const * > > const &)\n"
-    "    Datafield::Datafield(std::string const &,std::string const &,std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > const &)\n"
+    "    Datafield::Datafield(std::string const &,std::string const &,double2d_t const &)\n"
     "    Datafield::Datafield(Datafield const &)\n");
   return 0;
 }
@@ -43118,558 +43114,558 @@ static PyMethodDef SwigMethods[] = {
 		"SwigPyIterator___sub__(SwigPyIterator self, SwigPyIterator x) -> ptrdiff_t\n"
 		""},
 	 { "SwigPyIterator_swigregister", SwigPyIterator_swigregister, METH_O, NULL},
-	 { "vdouble1d_t_iterator", _wrap_vdouble1d_t_iterator, METH_O, "vdouble1d_t_iterator(vdouble1d_t self) -> SwigPyIterator"},
-	 { "vdouble1d_t___nonzero__", _wrap_vdouble1d_t___nonzero__, METH_O, "vdouble1d_t___nonzero__(vdouble1d_t self) -> bool"},
-	 { "vdouble1d_t___bool__", _wrap_vdouble1d_t___bool__, METH_O, "vdouble1d_t___bool__(vdouble1d_t self) -> bool"},
-	 { "vdouble1d_t___len__", _wrap_vdouble1d_t___len__, METH_O, "vdouble1d_t___len__(vdouble1d_t self) -> std::vector< double >::size_type"},
-	 { "vdouble1d_t___getslice__", _wrap_vdouble1d_t___getslice__, METH_VARARGS, "vdouble1d_t___getslice__(vdouble1d_t self, std::vector< double >::difference_type i, std::vector< double >::difference_type j) -> vdouble1d_t"},
-	 { "vdouble1d_t___setslice__", _wrap_vdouble1d_t___setslice__, METH_VARARGS, "\n"
-		"vdouble1d_t___setslice__(vdouble1d_t self, std::vector< double >::difference_type i, std::vector< double >::difference_type j)\n"
-		"vdouble1d_t___setslice__(vdouble1d_t self, std::vector< double >::difference_type i, std::vector< double >::difference_type j, vdouble1d_t v)\n"
+	 { "vdouble1d_T_iterator", _wrap_vdouble1d_T_iterator, METH_O, "vdouble1d_T_iterator(vdouble1d_T self) -> SwigPyIterator"},
+	 { "vdouble1d_T___nonzero__", _wrap_vdouble1d_T___nonzero__, METH_O, "vdouble1d_T___nonzero__(vdouble1d_T self) -> bool"},
+	 { "vdouble1d_T___bool__", _wrap_vdouble1d_T___bool__, METH_O, "vdouble1d_T___bool__(vdouble1d_T self) -> bool"},
+	 { "vdouble1d_T___len__", _wrap_vdouble1d_T___len__, METH_O, "vdouble1d_T___len__(vdouble1d_T self) -> std::vector< double >::size_type"},
+	 { "vdouble1d_T___getslice__", _wrap_vdouble1d_T___getslice__, METH_VARARGS, "vdouble1d_T___getslice__(vdouble1d_T self, std::vector< double >::difference_type i, std::vector< double >::difference_type j) -> vdouble1d_T"},
+	 { "vdouble1d_T___setslice__", _wrap_vdouble1d_T___setslice__, METH_VARARGS, "\n"
+		"vdouble1d_T___setslice__(vdouble1d_T self, std::vector< double >::difference_type i, std::vector< double >::difference_type j)\n"
+		"vdouble1d_T___setslice__(vdouble1d_T self, std::vector< double >::difference_type i, std::vector< double >::difference_type j, vdouble1d_T v)\n"
 		""},
-	 { "vdouble1d_t___delslice__", _wrap_vdouble1d_t___delslice__, METH_VARARGS, "vdouble1d_t___delslice__(vdouble1d_t self, std::vector< double >::difference_type i, std::vector< double >::difference_type j)"},
-	 { "vdouble1d_t___delitem__", _wrap_vdouble1d_t___delitem__, METH_VARARGS, "\n"
-		"vdouble1d_t___delitem__(vdouble1d_t self, std::vector< double >::difference_type i)\n"
-		"vdouble1d_t___delitem__(vdouble1d_t self, SWIGPY_SLICEOBJECT * slice)\n"
+	 { "vdouble1d_T___delslice__", _wrap_vdouble1d_T___delslice__, METH_VARARGS, "vdouble1d_T___delslice__(vdouble1d_T self, std::vector< double >::difference_type i, std::vector< double >::difference_type j)"},
+	 { "vdouble1d_T___delitem__", _wrap_vdouble1d_T___delitem__, METH_VARARGS, "\n"
+		"vdouble1d_T___delitem__(vdouble1d_T self, std::vector< double >::difference_type i)\n"
+		"vdouble1d_T___delitem__(vdouble1d_T self, SWIGPY_SLICEOBJECT * slice)\n"
 		""},
-	 { "vdouble1d_t___getitem__", _wrap_vdouble1d_t___getitem__, METH_VARARGS, "\n"
-		"vdouble1d_t___getitem__(vdouble1d_t self, SWIGPY_SLICEOBJECT * slice) -> vdouble1d_t\n"
-		"vdouble1d_t___getitem__(vdouble1d_t self, std::vector< double >::difference_type i) -> std::vector< double >::value_type const &\n"
+	 { "vdouble1d_T___getitem__", _wrap_vdouble1d_T___getitem__, METH_VARARGS, "\n"
+		"vdouble1d_T___getitem__(vdouble1d_T self, SWIGPY_SLICEOBJECT * slice) -> vdouble1d_T\n"
+		"vdouble1d_T___getitem__(vdouble1d_T self, std::vector< double >::difference_type i) -> std::vector< double >::value_type const &\n"
 		""},
-	 { "vdouble1d_t___setitem__", _wrap_vdouble1d_t___setitem__, METH_VARARGS, "\n"
-		"vdouble1d_t___setitem__(vdouble1d_t self, SWIGPY_SLICEOBJECT * slice, vdouble1d_t v)\n"
-		"vdouble1d_t___setitem__(vdouble1d_t self, SWIGPY_SLICEOBJECT * slice)\n"
-		"vdouble1d_t___setitem__(vdouble1d_t self, std::vector< double >::difference_type i, std::vector< double >::value_type const & x)\n"
+	 { "vdouble1d_T___setitem__", _wrap_vdouble1d_T___setitem__, METH_VARARGS, "\n"
+		"vdouble1d_T___setitem__(vdouble1d_T self, SWIGPY_SLICEOBJECT * slice, vdouble1d_T v)\n"
+		"vdouble1d_T___setitem__(vdouble1d_T self, SWIGPY_SLICEOBJECT * slice)\n"
+		"vdouble1d_T___setitem__(vdouble1d_T self, std::vector< double >::difference_type i, std::vector< double >::value_type const & x)\n"
 		""},
-	 { "vdouble1d_t_pop", _wrap_vdouble1d_t_pop, METH_O, "vdouble1d_t_pop(vdouble1d_t self) -> std::vector< double >::value_type"},
-	 { "vdouble1d_t_append", _wrap_vdouble1d_t_append, METH_VARARGS, "vdouble1d_t_append(vdouble1d_t self, std::vector< double >::value_type const & x)"},
-	 { "vdouble1d_t_empty", _wrap_vdouble1d_t_empty, METH_O, "vdouble1d_t_empty(vdouble1d_t self) -> bool"},
-	 { "vdouble1d_t_size", _wrap_vdouble1d_t_size, METH_O, "vdouble1d_t_size(vdouble1d_t self) -> std::vector< double >::size_type"},
-	 { "vdouble1d_t_swap", _wrap_vdouble1d_t_swap, METH_VARARGS, "vdouble1d_t_swap(vdouble1d_t self, vdouble1d_t v)"},
-	 { "vdouble1d_t_begin", _wrap_vdouble1d_t_begin, METH_O, "vdouble1d_t_begin(vdouble1d_t self) -> std::vector< double >::iterator"},
-	 { "vdouble1d_t_end", _wrap_vdouble1d_t_end, METH_O, "vdouble1d_t_end(vdouble1d_t self) -> std::vector< double >::iterator"},
-	 { "vdouble1d_t_rbegin", _wrap_vdouble1d_t_rbegin, METH_O, "vdouble1d_t_rbegin(vdouble1d_t self) -> std::vector< double >::reverse_iterator"},
-	 { "vdouble1d_t_rend", _wrap_vdouble1d_t_rend, METH_O, "vdouble1d_t_rend(vdouble1d_t self) -> std::vector< double >::reverse_iterator"},
-	 { "vdouble1d_t_clear", _wrap_vdouble1d_t_clear, METH_O, "vdouble1d_t_clear(vdouble1d_t self)"},
-	 { "vdouble1d_t_get_allocator", _wrap_vdouble1d_t_get_allocator, METH_O, "vdouble1d_t_get_allocator(vdouble1d_t self) -> std::vector< double >::allocator_type"},
-	 { "vdouble1d_t_pop_back", _wrap_vdouble1d_t_pop_back, METH_O, "vdouble1d_t_pop_back(vdouble1d_t self)"},
-	 { "vdouble1d_t_erase", _wrap_vdouble1d_t_erase, METH_VARARGS, "\n"
-		"vdouble1d_t_erase(vdouble1d_t self, std::vector< double >::iterator pos) -> std::vector< double >::iterator\n"
-		"vdouble1d_t_erase(vdouble1d_t self, std::vector< double >::iterator first, std::vector< double >::iterator last) -> std::vector< double >::iterator\n"
+	 { "vdouble1d_T_pop", _wrap_vdouble1d_T_pop, METH_O, "vdouble1d_T_pop(vdouble1d_T self) -> std::vector< double >::value_type"},
+	 { "vdouble1d_T_append", _wrap_vdouble1d_T_append, METH_VARARGS, "vdouble1d_T_append(vdouble1d_T self, std::vector< double >::value_type const & x)"},
+	 { "vdouble1d_T_empty", _wrap_vdouble1d_T_empty, METH_O, "vdouble1d_T_empty(vdouble1d_T self) -> bool"},
+	 { "vdouble1d_T_size", _wrap_vdouble1d_T_size, METH_O, "vdouble1d_T_size(vdouble1d_T self) -> std::vector< double >::size_type"},
+	 { "vdouble1d_T_swap", _wrap_vdouble1d_T_swap, METH_VARARGS, "vdouble1d_T_swap(vdouble1d_T self, vdouble1d_T v)"},
+	 { "vdouble1d_T_begin", _wrap_vdouble1d_T_begin, METH_O, "vdouble1d_T_begin(vdouble1d_T self) -> std::vector< double >::iterator"},
+	 { "vdouble1d_T_end", _wrap_vdouble1d_T_end, METH_O, "vdouble1d_T_end(vdouble1d_T self) -> std::vector< double >::iterator"},
+	 { "vdouble1d_T_rbegin", _wrap_vdouble1d_T_rbegin, METH_O, "vdouble1d_T_rbegin(vdouble1d_T self) -> std::vector< double >::reverse_iterator"},
+	 { "vdouble1d_T_rend", _wrap_vdouble1d_T_rend, METH_O, "vdouble1d_T_rend(vdouble1d_T self) -> std::vector< double >::reverse_iterator"},
+	 { "vdouble1d_T_clear", _wrap_vdouble1d_T_clear, METH_O, "vdouble1d_T_clear(vdouble1d_T self)"},
+	 { "vdouble1d_T_get_allocator", _wrap_vdouble1d_T_get_allocator, METH_O, "vdouble1d_T_get_allocator(vdouble1d_T self) -> std::vector< double >::allocator_type"},
+	 { "vdouble1d_T_pop_back", _wrap_vdouble1d_T_pop_back, METH_O, "vdouble1d_T_pop_back(vdouble1d_T self)"},
+	 { "vdouble1d_T_erase", _wrap_vdouble1d_T_erase, METH_VARARGS, "\n"
+		"vdouble1d_T_erase(vdouble1d_T self, std::vector< double >::iterator pos) -> std::vector< double >::iterator\n"
+		"vdouble1d_T_erase(vdouble1d_T self, std::vector< double >::iterator first, std::vector< double >::iterator last) -> std::vector< double >::iterator\n"
 		""},
-	 { "new_vdouble1d_t", _wrap_new_vdouble1d_t, METH_VARARGS, "\n"
-		"vdouble1d_t()\n"
-		"vdouble1d_t(vdouble1d_t other)\n"
-		"vdouble1d_t(std::vector< double >::size_type size)\n"
-		"new_vdouble1d_t(std::vector< double >::size_type size, std::vector< double >::value_type const & value) -> vdouble1d_t\n"
+	 { "new_vdouble1d_T", _wrap_new_vdouble1d_T, METH_VARARGS, "\n"
+		"vdouble1d_T()\n"
+		"vdouble1d_T(vdouble1d_T other)\n"
+		"vdouble1d_T(std::vector< double >::size_type size)\n"
+		"new_vdouble1d_T(std::vector< double >::size_type size, std::vector< double >::value_type const & value) -> vdouble1d_T\n"
 		""},
-	 { "vdouble1d_t_push_back", _wrap_vdouble1d_t_push_back, METH_VARARGS, "vdouble1d_t_push_back(vdouble1d_t self, std::vector< double >::value_type const & x)"},
-	 { "vdouble1d_t_front", _wrap_vdouble1d_t_front, METH_O, "vdouble1d_t_front(vdouble1d_t self) -> std::vector< double >::value_type const &"},
-	 { "vdouble1d_t_back", _wrap_vdouble1d_t_back, METH_O, "vdouble1d_t_back(vdouble1d_t self) -> std::vector< double >::value_type const &"},
-	 { "vdouble1d_t_assign", _wrap_vdouble1d_t_assign, METH_VARARGS, "vdouble1d_t_assign(vdouble1d_t self, std::vector< double >::size_type n, std::vector< double >::value_type const & x)"},
-	 { "vdouble1d_t_resize", _wrap_vdouble1d_t_resize, METH_VARARGS, "\n"
-		"vdouble1d_t_resize(vdouble1d_t self, std::vector< double >::size_type new_size)\n"
-		"vdouble1d_t_resize(vdouble1d_t self, std::vector< double >::size_type new_size, std::vector< double >::value_type const & x)\n"
+	 { "vdouble1d_T_push_back", _wrap_vdouble1d_T_push_back, METH_VARARGS, "vdouble1d_T_push_back(vdouble1d_T self, std::vector< double >::value_type const & x)"},
+	 { "vdouble1d_T_front", _wrap_vdouble1d_T_front, METH_O, "vdouble1d_T_front(vdouble1d_T self) -> std::vector< double >::value_type const &"},
+	 { "vdouble1d_T_back", _wrap_vdouble1d_T_back, METH_O, "vdouble1d_T_back(vdouble1d_T self) -> std::vector< double >::value_type const &"},
+	 { "vdouble1d_T_assign", _wrap_vdouble1d_T_assign, METH_VARARGS, "vdouble1d_T_assign(vdouble1d_T self, std::vector< double >::size_type n, std::vector< double >::value_type const & x)"},
+	 { "vdouble1d_T_resize", _wrap_vdouble1d_T_resize, METH_VARARGS, "\n"
+		"vdouble1d_T_resize(vdouble1d_T self, std::vector< double >::size_type new_size)\n"
+		"vdouble1d_T_resize(vdouble1d_T self, std::vector< double >::size_type new_size, std::vector< double >::value_type const & x)\n"
 		""},
-	 { "vdouble1d_t_insert", _wrap_vdouble1d_t_insert, METH_VARARGS, "\n"
-		"vdouble1d_t_insert(vdouble1d_t self, std::vector< double >::iterator pos, std::vector< double >::value_type const & x) -> std::vector< double >::iterator\n"
-		"vdouble1d_t_insert(vdouble1d_t self, std::vector< double >::iterator pos, std::vector< double >::size_type n, std::vector< double >::value_type const & x)\n"
+	 { "vdouble1d_T_insert", _wrap_vdouble1d_T_insert, METH_VARARGS, "\n"
+		"vdouble1d_T_insert(vdouble1d_T self, std::vector< double >::iterator pos, std::vector< double >::value_type const & x) -> std::vector< double >::iterator\n"
+		"vdouble1d_T_insert(vdouble1d_T self, std::vector< double >::iterator pos, std::vector< double >::size_type n, std::vector< double >::value_type const & x)\n"
 		""},
-	 { "vdouble1d_t_reserve", _wrap_vdouble1d_t_reserve, METH_VARARGS, "vdouble1d_t_reserve(vdouble1d_t self, std::vector< double >::size_type n)"},
-	 { "vdouble1d_t_capacity", _wrap_vdouble1d_t_capacity, METH_O, "vdouble1d_t_capacity(vdouble1d_t self) -> std::vector< double >::size_type"},
-	 { "delete_vdouble1d_t", _wrap_delete_vdouble1d_t, METH_O, "delete_vdouble1d_t(vdouble1d_t self)"},
-	 { "vdouble1d_t_swigregister", vdouble1d_t_swigregister, METH_O, NULL},
-	 { "vdouble1d_t_swiginit", vdouble1d_t_swiginit, METH_VARARGS, NULL},
-	 { "vdouble2d_t_iterator", _wrap_vdouble2d_t_iterator, METH_O, "vdouble2d_t_iterator(vdouble2d_t self) -> SwigPyIterator"},
-	 { "vdouble2d_t___nonzero__", _wrap_vdouble2d_t___nonzero__, METH_O, "vdouble2d_t___nonzero__(vdouble2d_t self) -> bool"},
-	 { "vdouble2d_t___bool__", _wrap_vdouble2d_t___bool__, METH_O, "vdouble2d_t___bool__(vdouble2d_t self) -> bool"},
-	 { "vdouble2d_t___len__", _wrap_vdouble2d_t___len__, METH_O, "vdouble2d_t___len__(vdouble2d_t self) -> std::vector< std::vector< double > >::size_type"},
-	 { "vdouble2d_t___getslice__", _wrap_vdouble2d_t___getslice__, METH_VARARGS, "vdouble2d_t___getslice__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j) -> vdouble2d_t"},
-	 { "vdouble2d_t___setslice__", _wrap_vdouble2d_t___setslice__, METH_VARARGS, "\n"
-		"vdouble2d_t___setslice__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j)\n"
-		"vdouble2d_t___setslice__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j, vdouble2d_t v)\n"
+	 { "vdouble1d_T_reserve", _wrap_vdouble1d_T_reserve, METH_VARARGS, "vdouble1d_T_reserve(vdouble1d_T self, std::vector< double >::size_type n)"},
+	 { "vdouble1d_T_capacity", _wrap_vdouble1d_T_capacity, METH_O, "vdouble1d_T_capacity(vdouble1d_T self) -> std::vector< double >::size_type"},
+	 { "delete_vdouble1d_T", _wrap_delete_vdouble1d_T, METH_O, "delete_vdouble1d_T(vdouble1d_T self)"},
+	 { "vdouble1d_T_swigregister", vdouble1d_T_swigregister, METH_O, NULL},
+	 { "vdouble1d_T_swiginit", vdouble1d_T_swiginit, METH_VARARGS, NULL},
+	 { "vdouble2d_T_iterator", _wrap_vdouble2d_T_iterator, METH_O, "vdouble2d_T_iterator(vdouble2d_T self) -> SwigPyIterator"},
+	 { "vdouble2d_T___nonzero__", _wrap_vdouble2d_T___nonzero__, METH_O, "vdouble2d_T___nonzero__(vdouble2d_T self) -> bool"},
+	 { "vdouble2d_T___bool__", _wrap_vdouble2d_T___bool__, METH_O, "vdouble2d_T___bool__(vdouble2d_T self) -> bool"},
+	 { "vdouble2d_T___len__", _wrap_vdouble2d_T___len__, METH_O, "vdouble2d_T___len__(vdouble2d_T self) -> std::vector< std::vector< double > >::size_type"},
+	 { "vdouble2d_T___getslice__", _wrap_vdouble2d_T___getslice__, METH_VARARGS, "vdouble2d_T___getslice__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j) -> vdouble2d_T"},
+	 { "vdouble2d_T___setslice__", _wrap_vdouble2d_T___setslice__, METH_VARARGS, "\n"
+		"vdouble2d_T___setslice__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j)\n"
+		"vdouble2d_T___setslice__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j, vdouble2d_T v)\n"
 		""},
-	 { "vdouble2d_t___delslice__", _wrap_vdouble2d_t___delslice__, METH_VARARGS, "vdouble2d_t___delslice__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j)"},
-	 { "vdouble2d_t___delitem__", _wrap_vdouble2d_t___delitem__, METH_VARARGS, "\n"
-		"vdouble2d_t___delitem__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i)\n"
-		"vdouble2d_t___delitem__(vdouble2d_t self, SWIGPY_SLICEOBJECT * slice)\n"
+	 { "vdouble2d_T___delslice__", _wrap_vdouble2d_T___delslice__, METH_VARARGS, "vdouble2d_T___delslice__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j)"},
+	 { "vdouble2d_T___delitem__", _wrap_vdouble2d_T___delitem__, METH_VARARGS, "\n"
+		"vdouble2d_T___delitem__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i)\n"
+		"vdouble2d_T___delitem__(vdouble2d_T self, SWIGPY_SLICEOBJECT * slice)\n"
 		""},
-	 { "vdouble2d_t___getitem__", _wrap_vdouble2d_t___getitem__, METH_VARARGS, "\n"
-		"vdouble2d_t___getitem__(vdouble2d_t self, SWIGPY_SLICEOBJECT * slice) -> vdouble2d_t\n"
-		"vdouble2d_t___getitem__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i) -> vdouble1d_t\n"
+	 { "vdouble2d_T___getitem__", _wrap_vdouble2d_T___getitem__, METH_VARARGS, "\n"
+		"vdouble2d_T___getitem__(vdouble2d_T self, SWIGPY_SLICEOBJECT * slice) -> vdouble2d_T\n"
+		"vdouble2d_T___getitem__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i) -> vdouble1d_T\n"
 		""},
-	 { "vdouble2d_t___setitem__", _wrap_vdouble2d_t___setitem__, METH_VARARGS, "\n"
-		"vdouble2d_t___setitem__(vdouble2d_t self, SWIGPY_SLICEOBJECT * slice, vdouble2d_t v)\n"
-		"vdouble2d_t___setitem__(vdouble2d_t self, SWIGPY_SLICEOBJECT * slice)\n"
-		"vdouble2d_t___setitem__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i, vdouble1d_t x)\n"
+	 { "vdouble2d_T___setitem__", _wrap_vdouble2d_T___setitem__, METH_VARARGS, "\n"
+		"vdouble2d_T___setitem__(vdouble2d_T self, SWIGPY_SLICEOBJECT * slice, vdouble2d_T v)\n"
+		"vdouble2d_T___setitem__(vdouble2d_T self, SWIGPY_SLICEOBJECT * slice)\n"
+		"vdouble2d_T___setitem__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i, vdouble1d_T x)\n"
 		""},
-	 { "vdouble2d_t_pop", _wrap_vdouble2d_t_pop, METH_O, "vdouble2d_t_pop(vdouble2d_t self) -> vdouble1d_t"},
-	 { "vdouble2d_t_append", _wrap_vdouble2d_t_append, METH_VARARGS, "vdouble2d_t_append(vdouble2d_t self, vdouble1d_t x)"},
-	 { "vdouble2d_t_empty", _wrap_vdouble2d_t_empty, METH_O, "vdouble2d_t_empty(vdouble2d_t self) -> bool"},
-	 { "vdouble2d_t_size", _wrap_vdouble2d_t_size, METH_O, "vdouble2d_t_size(vdouble2d_t self) -> std::vector< std::vector< double > >::size_type"},
-	 { "vdouble2d_t_swap", _wrap_vdouble2d_t_swap, METH_VARARGS, "vdouble2d_t_swap(vdouble2d_t self, vdouble2d_t v)"},
-	 { "vdouble2d_t_begin", _wrap_vdouble2d_t_begin, METH_O, "vdouble2d_t_begin(vdouble2d_t self) -> std::vector< std::vector< double > >::iterator"},
-	 { "vdouble2d_t_end", _wrap_vdouble2d_t_end, METH_O, "vdouble2d_t_end(vdouble2d_t self) -> std::vector< std::vector< double > >::iterator"},
-	 { "vdouble2d_t_rbegin", _wrap_vdouble2d_t_rbegin, METH_O, "vdouble2d_t_rbegin(vdouble2d_t self) -> std::vector< std::vector< double > >::reverse_iterator"},
-	 { "vdouble2d_t_rend", _wrap_vdouble2d_t_rend, METH_O, "vdouble2d_t_rend(vdouble2d_t self) -> std::vector< std::vector< double > >::reverse_iterator"},
-	 { "vdouble2d_t_clear", _wrap_vdouble2d_t_clear, METH_O, "vdouble2d_t_clear(vdouble2d_t self)"},
-	 { "vdouble2d_t_get_allocator", _wrap_vdouble2d_t_get_allocator, METH_O, "vdouble2d_t_get_allocator(vdouble2d_t self) -> std::vector< std::vector< double > >::allocator_type"},
-	 { "vdouble2d_t_pop_back", _wrap_vdouble2d_t_pop_back, METH_O, "vdouble2d_t_pop_back(vdouble2d_t self)"},
-	 { "vdouble2d_t_erase", _wrap_vdouble2d_t_erase, METH_VARARGS, "\n"
-		"vdouble2d_t_erase(vdouble2d_t self, std::vector< std::vector< double > >::iterator pos) -> std::vector< std::vector< double > >::iterator\n"
-		"vdouble2d_t_erase(vdouble2d_t self, std::vector< std::vector< double > >::iterator first, std::vector< std::vector< double > >::iterator last) -> std::vector< std::vector< double > >::iterator\n"
+	 { "vdouble2d_T_pop", _wrap_vdouble2d_T_pop, METH_O, "vdouble2d_T_pop(vdouble2d_T self) -> vdouble1d_T"},
+	 { "vdouble2d_T_append", _wrap_vdouble2d_T_append, METH_VARARGS, "vdouble2d_T_append(vdouble2d_T self, vdouble1d_T x)"},
+	 { "vdouble2d_T_empty", _wrap_vdouble2d_T_empty, METH_O, "vdouble2d_T_empty(vdouble2d_T self) -> bool"},
+	 { "vdouble2d_T_size", _wrap_vdouble2d_T_size, METH_O, "vdouble2d_T_size(vdouble2d_T self) -> std::vector< std::vector< double > >::size_type"},
+	 { "vdouble2d_T_swap", _wrap_vdouble2d_T_swap, METH_VARARGS, "vdouble2d_T_swap(vdouble2d_T self, vdouble2d_T v)"},
+	 { "vdouble2d_T_begin", _wrap_vdouble2d_T_begin, METH_O, "vdouble2d_T_begin(vdouble2d_T self) -> std::vector< std::vector< double > >::iterator"},
+	 { "vdouble2d_T_end", _wrap_vdouble2d_T_end, METH_O, "vdouble2d_T_end(vdouble2d_T self) -> std::vector< std::vector< double > >::iterator"},
+	 { "vdouble2d_T_rbegin", _wrap_vdouble2d_T_rbegin, METH_O, "vdouble2d_T_rbegin(vdouble2d_T self) -> std::vector< std::vector< double > >::reverse_iterator"},
+	 { "vdouble2d_T_rend", _wrap_vdouble2d_T_rend, METH_O, "vdouble2d_T_rend(vdouble2d_T self) -> std::vector< std::vector< double > >::reverse_iterator"},
+	 { "vdouble2d_T_clear", _wrap_vdouble2d_T_clear, METH_O, "vdouble2d_T_clear(vdouble2d_T self)"},
+	 { "vdouble2d_T_get_allocator", _wrap_vdouble2d_T_get_allocator, METH_O, "vdouble2d_T_get_allocator(vdouble2d_T self) -> std::vector< std::vector< double > >::allocator_type"},
+	 { "vdouble2d_T_pop_back", _wrap_vdouble2d_T_pop_back, METH_O, "vdouble2d_T_pop_back(vdouble2d_T self)"},
+	 { "vdouble2d_T_erase", _wrap_vdouble2d_T_erase, METH_VARARGS, "\n"
+		"vdouble2d_T_erase(vdouble2d_T self, std::vector< std::vector< double > >::iterator pos) -> std::vector< std::vector< double > >::iterator\n"
+		"vdouble2d_T_erase(vdouble2d_T self, std::vector< std::vector< double > >::iterator first, std::vector< std::vector< double > >::iterator last) -> std::vector< std::vector< double > >::iterator\n"
 		""},
-	 { "new_vdouble2d_t", _wrap_new_vdouble2d_t, METH_VARARGS, "\n"
-		"vdouble2d_t()\n"
-		"vdouble2d_t(vdouble2d_t other)\n"
-		"vdouble2d_t(std::vector< std::vector< double > >::size_type size)\n"
-		"new_vdouble2d_t(std::vector< std::vector< double > >::size_type size, vdouble1d_t value) -> vdouble2d_t\n"
+	 { "new_vdouble2d_T", _wrap_new_vdouble2d_T, METH_VARARGS, "\n"
+		"vdouble2d_T()\n"
+		"vdouble2d_T(vdouble2d_T other)\n"
+		"vdouble2d_T(std::vector< std::vector< double > >::size_type size)\n"
+		"new_vdouble2d_T(std::vector< std::vector< double > >::size_type size, vdouble1d_T value) -> vdouble2d_T\n"
 		""},
-	 { "vdouble2d_t_push_back", _wrap_vdouble2d_t_push_back, METH_VARARGS, "vdouble2d_t_push_back(vdouble2d_t self, vdouble1d_t x)"},
-	 { "vdouble2d_t_front", _wrap_vdouble2d_t_front, METH_O, "vdouble2d_t_front(vdouble2d_t self) -> vdouble1d_t"},
-	 { "vdouble2d_t_back", _wrap_vdouble2d_t_back, METH_O, "vdouble2d_t_back(vdouble2d_t self) -> vdouble1d_t"},
-	 { "vdouble2d_t_assign", _wrap_vdouble2d_t_assign, METH_VARARGS, "vdouble2d_t_assign(vdouble2d_t self, std::vector< std::vector< double > >::size_type n, vdouble1d_t x)"},
-	 { "vdouble2d_t_resize", _wrap_vdouble2d_t_resize, METH_VARARGS, "\n"
-		"vdouble2d_t_resize(vdouble2d_t self, std::vector< std::vector< double > >::size_type new_size)\n"
-		"vdouble2d_t_resize(vdouble2d_t self, std::vector< std::vector< double > >::size_type new_size, vdouble1d_t x)\n"
+	 { "vdouble2d_T_push_back", _wrap_vdouble2d_T_push_back, METH_VARARGS, "vdouble2d_T_push_back(vdouble2d_T self, vdouble1d_T x)"},
+	 { "vdouble2d_T_front", _wrap_vdouble2d_T_front, METH_O, "vdouble2d_T_front(vdouble2d_T self) -> vdouble1d_T"},
+	 { "vdouble2d_T_back", _wrap_vdouble2d_T_back, METH_O, "vdouble2d_T_back(vdouble2d_T self) -> vdouble1d_T"},
+	 { "vdouble2d_T_assign", _wrap_vdouble2d_T_assign, METH_VARARGS, "vdouble2d_T_assign(vdouble2d_T self, std::vector< std::vector< double > >::size_type n, vdouble1d_T x)"},
+	 { "vdouble2d_T_resize", _wrap_vdouble2d_T_resize, METH_VARARGS, "\n"
+		"vdouble2d_T_resize(vdouble2d_T self, std::vector< std::vector< double > >::size_type new_size)\n"
+		"vdouble2d_T_resize(vdouble2d_T self, std::vector< std::vector< double > >::size_type new_size, vdouble1d_T x)\n"
 		""},
-	 { "vdouble2d_t_insert", _wrap_vdouble2d_t_insert, METH_VARARGS, "\n"
-		"vdouble2d_t_insert(vdouble2d_t self, std::vector< std::vector< double > >::iterator pos, vdouble1d_t x) -> std::vector< std::vector< double > >::iterator\n"
-		"vdouble2d_t_insert(vdouble2d_t self, std::vector< std::vector< double > >::iterator pos, std::vector< std::vector< double > >::size_type n, vdouble1d_t x)\n"
+	 { "vdouble2d_T_insert", _wrap_vdouble2d_T_insert, METH_VARARGS, "\n"
+		"vdouble2d_T_insert(vdouble2d_T self, std::vector< std::vector< double > >::iterator pos, vdouble1d_T x) -> std::vector< std::vector< double > >::iterator\n"
+		"vdouble2d_T_insert(vdouble2d_T self, std::vector< std::vector< double > >::iterator pos, std::vector< std::vector< double > >::size_type n, vdouble1d_T x)\n"
 		""},
-	 { "vdouble2d_t_reserve", _wrap_vdouble2d_t_reserve, METH_VARARGS, "vdouble2d_t_reserve(vdouble2d_t self, std::vector< std::vector< double > >::size_type n)"},
-	 { "vdouble2d_t_capacity", _wrap_vdouble2d_t_capacity, METH_O, "vdouble2d_t_capacity(vdouble2d_t self) -> std::vector< std::vector< double > >::size_type"},
-	 { "delete_vdouble2d_t", _wrap_delete_vdouble2d_t, METH_O, "delete_vdouble2d_t(vdouble2d_t self)"},
-	 { "vdouble2d_t_swigregister", vdouble2d_t_swigregister, METH_O, NULL},
-	 { "vdouble2d_t_swiginit", vdouble2d_t_swiginit, METH_VARARGS, NULL},
-	 { "vector_integer_t_iterator", _wrap_vector_integer_t_iterator, METH_O, "vector_integer_t_iterator(vector_integer_t self) -> SwigPyIterator"},
-	 { "vector_integer_t___nonzero__", _wrap_vector_integer_t___nonzero__, METH_O, "vector_integer_t___nonzero__(vector_integer_t self) -> bool"},
-	 { "vector_integer_t___bool__", _wrap_vector_integer_t___bool__, METH_O, "vector_integer_t___bool__(vector_integer_t self) -> bool"},
-	 { "vector_integer_t___len__", _wrap_vector_integer_t___len__, METH_O, "vector_integer_t___len__(vector_integer_t self) -> std::vector< int >::size_type"},
-	 { "vector_integer_t___getslice__", _wrap_vector_integer_t___getslice__, METH_VARARGS, "vector_integer_t___getslice__(vector_integer_t self, std::vector< int >::difference_type i, std::vector< int >::difference_type j) -> vector_integer_t"},
-	 { "vector_integer_t___setslice__", _wrap_vector_integer_t___setslice__, METH_VARARGS, "\n"
-		"vector_integer_t___setslice__(vector_integer_t self, std::vector< int >::difference_type i, std::vector< int >::difference_type j)\n"
-		"vector_integer_t___setslice__(vector_integer_t self, std::vector< int >::difference_type i, std::vector< int >::difference_type j, vector_integer_t v)\n"
+	 { "vdouble2d_T_reserve", _wrap_vdouble2d_T_reserve, METH_VARARGS, "vdouble2d_T_reserve(vdouble2d_T self, std::vector< std::vector< double > >::size_type n)"},
+	 { "vdouble2d_T_capacity", _wrap_vdouble2d_T_capacity, METH_O, "vdouble2d_T_capacity(vdouble2d_T self) -> std::vector< std::vector< double > >::size_type"},
+	 { "delete_vdouble2d_T", _wrap_delete_vdouble2d_T, METH_O, "delete_vdouble2d_T(vdouble2d_T self)"},
+	 { "vdouble2d_T_swigregister", vdouble2d_T_swigregister, METH_O, NULL},
+	 { "vdouble2d_T_swiginit", vdouble2d_T_swiginit, METH_VARARGS, NULL},
+	 { "vector_integer_T_iterator", _wrap_vector_integer_T_iterator, METH_O, "vector_integer_T_iterator(vector_integer_T self) -> SwigPyIterator"},
+	 { "vector_integer_T___nonzero__", _wrap_vector_integer_T___nonzero__, METH_O, "vector_integer_T___nonzero__(vector_integer_T self) -> bool"},
+	 { "vector_integer_T___bool__", _wrap_vector_integer_T___bool__, METH_O, "vector_integer_T___bool__(vector_integer_T self) -> bool"},
+	 { "vector_integer_T___len__", _wrap_vector_integer_T___len__, METH_O, "vector_integer_T___len__(vector_integer_T self) -> std::vector< int >::size_type"},
+	 { "vector_integer_T___getslice__", _wrap_vector_integer_T___getslice__, METH_VARARGS, "vector_integer_T___getslice__(vector_integer_T self, std::vector< int >::difference_type i, std::vector< int >::difference_type j) -> vector_integer_T"},
+	 { "vector_integer_T___setslice__", _wrap_vector_integer_T___setslice__, METH_VARARGS, "\n"
+		"vector_integer_T___setslice__(vector_integer_T self, std::vector< int >::difference_type i, std::vector< int >::difference_type j)\n"
+		"vector_integer_T___setslice__(vector_integer_T self, std::vector< int >::difference_type i, std::vector< int >::difference_type j, vector_integer_T v)\n"
 		""},
-	 { "vector_integer_t___delslice__", _wrap_vector_integer_t___delslice__, METH_VARARGS, "vector_integer_t___delslice__(vector_integer_t self, std::vector< int >::difference_type i, std::vector< int >::difference_type j)"},
-	 { "vector_integer_t___delitem__", _wrap_vector_integer_t___delitem__, METH_VARARGS, "\n"
-		"vector_integer_t___delitem__(vector_integer_t self, std::vector< int >::difference_type i)\n"
-		"vector_integer_t___delitem__(vector_integer_t self, SWIGPY_SLICEOBJECT * slice)\n"
+	 { "vector_integer_T___delslice__", _wrap_vector_integer_T___delslice__, METH_VARARGS, "vector_integer_T___delslice__(vector_integer_T self, std::vector< int >::difference_type i, std::vector< int >::difference_type j)"},
+	 { "vector_integer_T___delitem__", _wrap_vector_integer_T___delitem__, METH_VARARGS, "\n"
+		"vector_integer_T___delitem__(vector_integer_T self, std::vector< int >::difference_type i)\n"
+		"vector_integer_T___delitem__(vector_integer_T self, SWIGPY_SLICEOBJECT * slice)\n"
 		""},
-	 { "vector_integer_t___getitem__", _wrap_vector_integer_t___getitem__, METH_VARARGS, "\n"
-		"vector_integer_t___getitem__(vector_integer_t self, SWIGPY_SLICEOBJECT * slice) -> vector_integer_t\n"
-		"vector_integer_t___getitem__(vector_integer_t self, std::vector< int >::difference_type i) -> std::vector< int >::value_type const &\n"
+	 { "vector_integer_T___getitem__", _wrap_vector_integer_T___getitem__, METH_VARARGS, "\n"
+		"vector_integer_T___getitem__(vector_integer_T self, SWIGPY_SLICEOBJECT * slice) -> vector_integer_T\n"
+		"vector_integer_T___getitem__(vector_integer_T self, std::vector< int >::difference_type i) -> std::vector< int >::value_type const &\n"
 		""},
-	 { "vector_integer_t___setitem__", _wrap_vector_integer_t___setitem__, METH_VARARGS, "\n"
-		"vector_integer_t___setitem__(vector_integer_t self, SWIGPY_SLICEOBJECT * slice, vector_integer_t v)\n"
-		"vector_integer_t___setitem__(vector_integer_t self, SWIGPY_SLICEOBJECT * slice)\n"
-		"vector_integer_t___setitem__(vector_integer_t self, std::vector< int >::difference_type i, std::vector< int >::value_type const & x)\n"
+	 { "vector_integer_T___setitem__", _wrap_vector_integer_T___setitem__, METH_VARARGS, "\n"
+		"vector_integer_T___setitem__(vector_integer_T self, SWIGPY_SLICEOBJECT * slice, vector_integer_T v)\n"
+		"vector_integer_T___setitem__(vector_integer_T self, SWIGPY_SLICEOBJECT * slice)\n"
+		"vector_integer_T___setitem__(vector_integer_T self, std::vector< int >::difference_type i, std::vector< int >::value_type const & x)\n"
 		""},
-	 { "vector_integer_t_pop", _wrap_vector_integer_t_pop, METH_O, "vector_integer_t_pop(vector_integer_t self) -> std::vector< int >::value_type"},
-	 { "vector_integer_t_append", _wrap_vector_integer_t_append, METH_VARARGS, "vector_integer_t_append(vector_integer_t self, std::vector< int >::value_type const & x)"},
-	 { "vector_integer_t_empty", _wrap_vector_integer_t_empty, METH_O, "vector_integer_t_empty(vector_integer_t self) -> bool"},
-	 { "vector_integer_t_size", _wrap_vector_integer_t_size, METH_O, "vector_integer_t_size(vector_integer_t self) -> std::vector< int >::size_type"},
-	 { "vector_integer_t_swap", _wrap_vector_integer_t_swap, METH_VARARGS, "vector_integer_t_swap(vector_integer_t self, vector_integer_t v)"},
-	 { "vector_integer_t_begin", _wrap_vector_integer_t_begin, METH_O, "vector_integer_t_begin(vector_integer_t self) -> std::vector< int >::iterator"},
-	 { "vector_integer_t_end", _wrap_vector_integer_t_end, METH_O, "vector_integer_t_end(vector_integer_t self) -> std::vector< int >::iterator"},
-	 { "vector_integer_t_rbegin", _wrap_vector_integer_t_rbegin, METH_O, "vector_integer_t_rbegin(vector_integer_t self) -> std::vector< int >::reverse_iterator"},
-	 { "vector_integer_t_rend", _wrap_vector_integer_t_rend, METH_O, "vector_integer_t_rend(vector_integer_t self) -> std::vector< int >::reverse_iterator"},
-	 { "vector_integer_t_clear", _wrap_vector_integer_t_clear, METH_O, "vector_integer_t_clear(vector_integer_t self)"},
-	 { "vector_integer_t_get_allocator", _wrap_vector_integer_t_get_allocator, METH_O, "vector_integer_t_get_allocator(vector_integer_t self) -> std::vector< int >::allocator_type"},
-	 { "vector_integer_t_pop_back", _wrap_vector_integer_t_pop_back, METH_O, "vector_integer_t_pop_back(vector_integer_t self)"},
-	 { "vector_integer_t_erase", _wrap_vector_integer_t_erase, METH_VARARGS, "\n"
-		"vector_integer_t_erase(vector_integer_t self, std::vector< int >::iterator pos) -> std::vector< int >::iterator\n"
-		"vector_integer_t_erase(vector_integer_t self, std::vector< int >::iterator first, std::vector< int >::iterator last) -> std::vector< int >::iterator\n"
+	 { "vector_integer_T_pop", _wrap_vector_integer_T_pop, METH_O, "vector_integer_T_pop(vector_integer_T self) -> std::vector< int >::value_type"},
+	 { "vector_integer_T_append", _wrap_vector_integer_T_append, METH_VARARGS, "vector_integer_T_append(vector_integer_T self, std::vector< int >::value_type const & x)"},
+	 { "vector_integer_T_empty", _wrap_vector_integer_T_empty, METH_O, "vector_integer_T_empty(vector_integer_T self) -> bool"},
+	 { "vector_integer_T_size", _wrap_vector_integer_T_size, METH_O, "vector_integer_T_size(vector_integer_T self) -> std::vector< int >::size_type"},
+	 { "vector_integer_T_swap", _wrap_vector_integer_T_swap, METH_VARARGS, "vector_integer_T_swap(vector_integer_T self, vector_integer_T v)"},
+	 { "vector_integer_T_begin", _wrap_vector_integer_T_begin, METH_O, "vector_integer_T_begin(vector_integer_T self) -> std::vector< int >::iterator"},
+	 { "vector_integer_T_end", _wrap_vector_integer_T_end, METH_O, "vector_integer_T_end(vector_integer_T self) -> std::vector< int >::iterator"},
+	 { "vector_integer_T_rbegin", _wrap_vector_integer_T_rbegin, METH_O, "vector_integer_T_rbegin(vector_integer_T self) -> std::vector< int >::reverse_iterator"},
+	 { "vector_integer_T_rend", _wrap_vector_integer_T_rend, METH_O, "vector_integer_T_rend(vector_integer_T self) -> std::vector< int >::reverse_iterator"},
+	 { "vector_integer_T_clear", _wrap_vector_integer_T_clear, METH_O, "vector_integer_T_clear(vector_integer_T self)"},
+	 { "vector_integer_T_get_allocator", _wrap_vector_integer_T_get_allocator, METH_O, "vector_integer_T_get_allocator(vector_integer_T self) -> std::vector< int >::allocator_type"},
+	 { "vector_integer_T_pop_back", _wrap_vector_integer_T_pop_back, METH_O, "vector_integer_T_pop_back(vector_integer_T self)"},
+	 { "vector_integer_T_erase", _wrap_vector_integer_T_erase, METH_VARARGS, "\n"
+		"vector_integer_T_erase(vector_integer_T self, std::vector< int >::iterator pos) -> std::vector< int >::iterator\n"
+		"vector_integer_T_erase(vector_integer_T self, std::vector< int >::iterator first, std::vector< int >::iterator last) -> std::vector< int >::iterator\n"
 		""},
-	 { "new_vector_integer_t", _wrap_new_vector_integer_t, METH_VARARGS, "\n"
-		"vector_integer_t()\n"
-		"vector_integer_t(vector_integer_t other)\n"
-		"vector_integer_t(std::vector< int >::size_type size)\n"
-		"new_vector_integer_t(std::vector< int >::size_type size, std::vector< int >::value_type const & value) -> vector_integer_t\n"
+	 { "new_vector_integer_T", _wrap_new_vector_integer_T, METH_VARARGS, "\n"
+		"vector_integer_T()\n"
+		"vector_integer_T(vector_integer_T other)\n"
+		"vector_integer_T(std::vector< int >::size_type size)\n"
+		"new_vector_integer_T(std::vector< int >::size_type size, std::vector< int >::value_type const & value) -> vector_integer_T\n"
 		""},
-	 { "vector_integer_t_push_back", _wrap_vector_integer_t_push_back, METH_VARARGS, "vector_integer_t_push_back(vector_integer_t self, std::vector< int >::value_type const & x)"},
-	 { "vector_integer_t_front", _wrap_vector_integer_t_front, METH_O, "vector_integer_t_front(vector_integer_t self) -> std::vector< int >::value_type const &"},
-	 { "vector_integer_t_back", _wrap_vector_integer_t_back, METH_O, "vector_integer_t_back(vector_integer_t self) -> std::vector< int >::value_type const &"},
-	 { "vector_integer_t_assign", _wrap_vector_integer_t_assign, METH_VARARGS, "vector_integer_t_assign(vector_integer_t self, std::vector< int >::size_type n, std::vector< int >::value_type const & x)"},
-	 { "vector_integer_t_resize", _wrap_vector_integer_t_resize, METH_VARARGS, "\n"
-		"vector_integer_t_resize(vector_integer_t self, std::vector< int >::size_type new_size)\n"
-		"vector_integer_t_resize(vector_integer_t self, std::vector< int >::size_type new_size, std::vector< int >::value_type const & x)\n"
+	 { "vector_integer_T_push_back", _wrap_vector_integer_T_push_back, METH_VARARGS, "vector_integer_T_push_back(vector_integer_T self, std::vector< int >::value_type const & x)"},
+	 { "vector_integer_T_front", _wrap_vector_integer_T_front, METH_O, "vector_integer_T_front(vector_integer_T self) -> std::vector< int >::value_type const &"},
+	 { "vector_integer_T_back", _wrap_vector_integer_T_back, METH_O, "vector_integer_T_back(vector_integer_T self) -> std::vector< int >::value_type const &"},
+	 { "vector_integer_T_assign", _wrap_vector_integer_T_assign, METH_VARARGS, "vector_integer_T_assign(vector_integer_T self, std::vector< int >::size_type n, std::vector< int >::value_type const & x)"},
+	 { "vector_integer_T_resize", _wrap_vector_integer_T_resize, METH_VARARGS, "\n"
+		"vector_integer_T_resize(vector_integer_T self, std::vector< int >::size_type new_size)\n"
+		"vector_integer_T_resize(vector_integer_T self, std::vector< int >::size_type new_size, std::vector< int >::value_type const & x)\n"
 		""},
-	 { "vector_integer_t_insert", _wrap_vector_integer_t_insert, METH_VARARGS, "\n"
-		"vector_integer_t_insert(vector_integer_t self, std::vector< int >::iterator pos, std::vector< int >::value_type const & x) -> std::vector< int >::iterator\n"
-		"vector_integer_t_insert(vector_integer_t self, std::vector< int >::iterator pos, std::vector< int >::size_type n, std::vector< int >::value_type const & x)\n"
+	 { "vector_integer_T_insert", _wrap_vector_integer_T_insert, METH_VARARGS, "\n"
+		"vector_integer_T_insert(vector_integer_T self, std::vector< int >::iterator pos, std::vector< int >::value_type const & x) -> std::vector< int >::iterator\n"
+		"vector_integer_T_insert(vector_integer_T self, std::vector< int >::iterator pos, std::vector< int >::size_type n, std::vector< int >::value_type const & x)\n"
 		""},
-	 { "vector_integer_t_reserve", _wrap_vector_integer_t_reserve, METH_VARARGS, "vector_integer_t_reserve(vector_integer_t self, std::vector< int >::size_type n)"},
-	 { "vector_integer_t_capacity", _wrap_vector_integer_t_capacity, METH_O, "vector_integer_t_capacity(vector_integer_t self) -> std::vector< int >::size_type"},
-	 { "delete_vector_integer_t", _wrap_delete_vector_integer_t, METH_O, "delete_vector_integer_t(vector_integer_t self)"},
-	 { "vector_integer_t_swigregister", vector_integer_t_swigregister, METH_O, NULL},
-	 { "vector_integer_t_swiginit", vector_integer_t_swiginit, METH_VARARGS, NULL},
-	 { "vinteger2d_t_iterator", _wrap_vinteger2d_t_iterator, METH_O, "vinteger2d_t_iterator(vinteger2d_t self) -> SwigPyIterator"},
-	 { "vinteger2d_t___nonzero__", _wrap_vinteger2d_t___nonzero__, METH_O, "vinteger2d_t___nonzero__(vinteger2d_t self) -> bool"},
-	 { "vinteger2d_t___bool__", _wrap_vinteger2d_t___bool__, METH_O, "vinteger2d_t___bool__(vinteger2d_t self) -> bool"},
-	 { "vinteger2d_t___len__", _wrap_vinteger2d_t___len__, METH_O, "vinteger2d_t___len__(vinteger2d_t self) -> std::vector< std::vector< int > >::size_type"},
-	 { "vinteger2d_t___getslice__", _wrap_vinteger2d_t___getslice__, METH_VARARGS, "vinteger2d_t___getslice__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j) -> vinteger2d_t"},
-	 { "vinteger2d_t___setslice__", _wrap_vinteger2d_t___setslice__, METH_VARARGS, "\n"
-		"vinteger2d_t___setslice__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j)\n"
-		"vinteger2d_t___setslice__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j, vinteger2d_t v)\n"
+	 { "vector_integer_T_reserve", _wrap_vector_integer_T_reserve, METH_VARARGS, "vector_integer_T_reserve(vector_integer_T self, std::vector< int >::size_type n)"},
+	 { "vector_integer_T_capacity", _wrap_vector_integer_T_capacity, METH_O, "vector_integer_T_capacity(vector_integer_T self) -> std::vector< int >::size_type"},
+	 { "delete_vector_integer_T", _wrap_delete_vector_integer_T, METH_O, "delete_vector_integer_T(vector_integer_T self)"},
+	 { "vector_integer_T_swigregister", vector_integer_T_swigregister, METH_O, NULL},
+	 { "vector_integer_T_swiginit", vector_integer_T_swiginit, METH_VARARGS, NULL},
+	 { "vinteger2d_T_iterator", _wrap_vinteger2d_T_iterator, METH_O, "vinteger2d_T_iterator(vinteger2d_T self) -> SwigPyIterator"},
+	 { "vinteger2d_T___nonzero__", _wrap_vinteger2d_T___nonzero__, METH_O, "vinteger2d_T___nonzero__(vinteger2d_T self) -> bool"},
+	 { "vinteger2d_T___bool__", _wrap_vinteger2d_T___bool__, METH_O, "vinteger2d_T___bool__(vinteger2d_T self) -> bool"},
+	 { "vinteger2d_T___len__", _wrap_vinteger2d_T___len__, METH_O, "vinteger2d_T___len__(vinteger2d_T self) -> std::vector< std::vector< int > >::size_type"},
+	 { "vinteger2d_T___getslice__", _wrap_vinteger2d_T___getslice__, METH_VARARGS, "vinteger2d_T___getslice__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j) -> vinteger2d_T"},
+	 { "vinteger2d_T___setslice__", _wrap_vinteger2d_T___setslice__, METH_VARARGS, "\n"
+		"vinteger2d_T___setslice__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j)\n"
+		"vinteger2d_T___setslice__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j, vinteger2d_T v)\n"
 		""},
-	 { "vinteger2d_t___delslice__", _wrap_vinteger2d_t___delslice__, METH_VARARGS, "vinteger2d_t___delslice__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j)"},
-	 { "vinteger2d_t___delitem__", _wrap_vinteger2d_t___delitem__, METH_VARARGS, "\n"
-		"vinteger2d_t___delitem__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i)\n"
-		"vinteger2d_t___delitem__(vinteger2d_t self, SWIGPY_SLICEOBJECT * slice)\n"
+	 { "vinteger2d_T___delslice__", _wrap_vinteger2d_T___delslice__, METH_VARARGS, "vinteger2d_T___delslice__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j)"},
+	 { "vinteger2d_T___delitem__", _wrap_vinteger2d_T___delitem__, METH_VARARGS, "\n"
+		"vinteger2d_T___delitem__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i)\n"
+		"vinteger2d_T___delitem__(vinteger2d_T self, SWIGPY_SLICEOBJECT * slice)\n"
 		""},
-	 { "vinteger2d_t___getitem__", _wrap_vinteger2d_t___getitem__, METH_VARARGS, "\n"
-		"vinteger2d_t___getitem__(vinteger2d_t self, SWIGPY_SLICEOBJECT * slice) -> vinteger2d_t\n"
-		"vinteger2d_t___getitem__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i) -> vector_integer_t\n"
+	 { "vinteger2d_T___getitem__", _wrap_vinteger2d_T___getitem__, METH_VARARGS, "\n"
+		"vinteger2d_T___getitem__(vinteger2d_T self, SWIGPY_SLICEOBJECT * slice) -> vinteger2d_T\n"
+		"vinteger2d_T___getitem__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i) -> vector_integer_T\n"
 		""},
-	 { "vinteger2d_t___setitem__", _wrap_vinteger2d_t___setitem__, METH_VARARGS, "\n"
-		"vinteger2d_t___setitem__(vinteger2d_t self, SWIGPY_SLICEOBJECT * slice, vinteger2d_t v)\n"
-		"vinteger2d_t___setitem__(vinteger2d_t self, SWIGPY_SLICEOBJECT * slice)\n"
-		"vinteger2d_t___setitem__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i, vector_integer_t x)\n"
+	 { "vinteger2d_T___setitem__", _wrap_vinteger2d_T___setitem__, METH_VARARGS, "\n"
+		"vinteger2d_T___setitem__(vinteger2d_T self, SWIGPY_SLICEOBJECT * slice, vinteger2d_T v)\n"
+		"vinteger2d_T___setitem__(vinteger2d_T self, SWIGPY_SLICEOBJECT * slice)\n"
+		"vinteger2d_T___setitem__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i, vector_integer_T x)\n"
 		""},
-	 { "vinteger2d_t_pop", _wrap_vinteger2d_t_pop, METH_O, "vinteger2d_t_pop(vinteger2d_t self) -> vector_integer_t"},
-	 { "vinteger2d_t_append", _wrap_vinteger2d_t_append, METH_VARARGS, "vinteger2d_t_append(vinteger2d_t self, vector_integer_t x)"},
-	 { "vinteger2d_t_empty", _wrap_vinteger2d_t_empty, METH_O, "vinteger2d_t_empty(vinteger2d_t self) -> bool"},
-	 { "vinteger2d_t_size", _wrap_vinteger2d_t_size, METH_O, "vinteger2d_t_size(vinteger2d_t self) -> std::vector< std::vector< int > >::size_type"},
-	 { "vinteger2d_t_swap", _wrap_vinteger2d_t_swap, METH_VARARGS, "vinteger2d_t_swap(vinteger2d_t self, vinteger2d_t v)"},
-	 { "vinteger2d_t_begin", _wrap_vinteger2d_t_begin, METH_O, "vinteger2d_t_begin(vinteger2d_t self) -> std::vector< std::vector< int > >::iterator"},
-	 { "vinteger2d_t_end", _wrap_vinteger2d_t_end, METH_O, "vinteger2d_t_end(vinteger2d_t self) -> std::vector< std::vector< int > >::iterator"},
-	 { "vinteger2d_t_rbegin", _wrap_vinteger2d_t_rbegin, METH_O, "vinteger2d_t_rbegin(vinteger2d_t self) -> std::vector< std::vector< int > >::reverse_iterator"},
-	 { "vinteger2d_t_rend", _wrap_vinteger2d_t_rend, METH_O, "vinteger2d_t_rend(vinteger2d_t self) -> std::vector< std::vector< int > >::reverse_iterator"},
-	 { "vinteger2d_t_clear", _wrap_vinteger2d_t_clear, METH_O, "vinteger2d_t_clear(vinteger2d_t self)"},
-	 { "vinteger2d_t_get_allocator", _wrap_vinteger2d_t_get_allocator, METH_O, "vinteger2d_t_get_allocator(vinteger2d_t self) -> std::vector< std::vector< int > >::allocator_type"},
-	 { "vinteger2d_t_pop_back", _wrap_vinteger2d_t_pop_back, METH_O, "vinteger2d_t_pop_back(vinteger2d_t self)"},
-	 { "vinteger2d_t_erase", _wrap_vinteger2d_t_erase, METH_VARARGS, "\n"
-		"vinteger2d_t_erase(vinteger2d_t self, std::vector< std::vector< int > >::iterator pos) -> std::vector< std::vector< int > >::iterator\n"
-		"vinteger2d_t_erase(vinteger2d_t self, std::vector< std::vector< int > >::iterator first, std::vector< std::vector< int > >::iterator last) -> std::vector< std::vector< int > >::iterator\n"
+	 { "vinteger2d_T_pop", _wrap_vinteger2d_T_pop, METH_O, "vinteger2d_T_pop(vinteger2d_T self) -> vector_integer_T"},
+	 { "vinteger2d_T_append", _wrap_vinteger2d_T_append, METH_VARARGS, "vinteger2d_T_append(vinteger2d_T self, vector_integer_T x)"},
+	 { "vinteger2d_T_empty", _wrap_vinteger2d_T_empty, METH_O, "vinteger2d_T_empty(vinteger2d_T self) -> bool"},
+	 { "vinteger2d_T_size", _wrap_vinteger2d_T_size, METH_O, "vinteger2d_T_size(vinteger2d_T self) -> std::vector< std::vector< int > >::size_type"},
+	 { "vinteger2d_T_swap", _wrap_vinteger2d_T_swap, METH_VARARGS, "vinteger2d_T_swap(vinteger2d_T self, vinteger2d_T v)"},
+	 { "vinteger2d_T_begin", _wrap_vinteger2d_T_begin, METH_O, "vinteger2d_T_begin(vinteger2d_T self) -> std::vector< std::vector< int > >::iterator"},
+	 { "vinteger2d_T_end", _wrap_vinteger2d_T_end, METH_O, "vinteger2d_T_end(vinteger2d_T self) -> std::vector< std::vector< int > >::iterator"},
+	 { "vinteger2d_T_rbegin", _wrap_vinteger2d_T_rbegin, METH_O, "vinteger2d_T_rbegin(vinteger2d_T self) -> std::vector< std::vector< int > >::reverse_iterator"},
+	 { "vinteger2d_T_rend", _wrap_vinteger2d_T_rend, METH_O, "vinteger2d_T_rend(vinteger2d_T self) -> std::vector< std::vector< int > >::reverse_iterator"},
+	 { "vinteger2d_T_clear", _wrap_vinteger2d_T_clear, METH_O, "vinteger2d_T_clear(vinteger2d_T self)"},
+	 { "vinteger2d_T_get_allocator", _wrap_vinteger2d_T_get_allocator, METH_O, "vinteger2d_T_get_allocator(vinteger2d_T self) -> std::vector< std::vector< int > >::allocator_type"},
+	 { "vinteger2d_T_pop_back", _wrap_vinteger2d_T_pop_back, METH_O, "vinteger2d_T_pop_back(vinteger2d_T self)"},
+	 { "vinteger2d_T_erase", _wrap_vinteger2d_T_erase, METH_VARARGS, "\n"
+		"vinteger2d_T_erase(vinteger2d_T self, std::vector< std::vector< int > >::iterator pos) -> std::vector< std::vector< int > >::iterator\n"
+		"vinteger2d_T_erase(vinteger2d_T self, std::vector< std::vector< int > >::iterator first, std::vector< std::vector< int > >::iterator last) -> std::vector< std::vector< int > >::iterator\n"
 		""},
-	 { "new_vinteger2d_t", _wrap_new_vinteger2d_t, METH_VARARGS, "\n"
-		"vinteger2d_t()\n"
-		"vinteger2d_t(vinteger2d_t other)\n"
-		"vinteger2d_t(std::vector< std::vector< int > >::size_type size)\n"
-		"new_vinteger2d_t(std::vector< std::vector< int > >::size_type size, vector_integer_t value) -> vinteger2d_t\n"
+	 { "new_vinteger2d_T", _wrap_new_vinteger2d_T, METH_VARARGS, "\n"
+		"vinteger2d_T()\n"
+		"vinteger2d_T(vinteger2d_T other)\n"
+		"vinteger2d_T(std::vector< std::vector< int > >::size_type size)\n"
+		"new_vinteger2d_T(std::vector< std::vector< int > >::size_type size, vector_integer_T value) -> vinteger2d_T\n"
 		""},
-	 { "vinteger2d_t_push_back", _wrap_vinteger2d_t_push_back, METH_VARARGS, "vinteger2d_t_push_back(vinteger2d_t self, vector_integer_t x)"},
-	 { "vinteger2d_t_front", _wrap_vinteger2d_t_front, METH_O, "vinteger2d_t_front(vinteger2d_t self) -> vector_integer_t"},
-	 { "vinteger2d_t_back", _wrap_vinteger2d_t_back, METH_O, "vinteger2d_t_back(vinteger2d_t self) -> vector_integer_t"},
-	 { "vinteger2d_t_assign", _wrap_vinteger2d_t_assign, METH_VARARGS, "vinteger2d_t_assign(vinteger2d_t self, std::vector< std::vector< int > >::size_type n, vector_integer_t x)"},
-	 { "vinteger2d_t_resize", _wrap_vinteger2d_t_resize, METH_VARARGS, "\n"
-		"vinteger2d_t_resize(vinteger2d_t self, std::vector< std::vector< int > >::size_type new_size)\n"
-		"vinteger2d_t_resize(vinteger2d_t self, std::vector< std::vector< int > >::size_type new_size, vector_integer_t x)\n"
+	 { "vinteger2d_T_push_back", _wrap_vinteger2d_T_push_back, METH_VARARGS, "vinteger2d_T_push_back(vinteger2d_T self, vector_integer_T x)"},
+	 { "vinteger2d_T_front", _wrap_vinteger2d_T_front, METH_O, "vinteger2d_T_front(vinteger2d_T self) -> vector_integer_T"},
+	 { "vinteger2d_T_back", _wrap_vinteger2d_T_back, METH_O, "vinteger2d_T_back(vinteger2d_T self) -> vector_integer_T"},
+	 { "vinteger2d_T_assign", _wrap_vinteger2d_T_assign, METH_VARARGS, "vinteger2d_T_assign(vinteger2d_T self, std::vector< std::vector< int > >::size_type n, vector_integer_T x)"},
+	 { "vinteger2d_T_resize", _wrap_vinteger2d_T_resize, METH_VARARGS, "\n"
+		"vinteger2d_T_resize(vinteger2d_T self, std::vector< std::vector< int > >::size_type new_size)\n"
+		"vinteger2d_T_resize(vinteger2d_T self, std::vector< std::vector< int > >::size_type new_size, vector_integer_T x)\n"
 		""},
-	 { "vinteger2d_t_insert", _wrap_vinteger2d_t_insert, METH_VARARGS, "\n"
-		"vinteger2d_t_insert(vinteger2d_t self, std::vector< std::vector< int > >::iterator pos, vector_integer_t x) -> std::vector< std::vector< int > >::iterator\n"
-		"vinteger2d_t_insert(vinteger2d_t self, std::vector< std::vector< int > >::iterator pos, std::vector< std::vector< int > >::size_type n, vector_integer_t x)\n"
+	 { "vinteger2d_T_insert", _wrap_vinteger2d_T_insert, METH_VARARGS, "\n"
+		"vinteger2d_T_insert(vinteger2d_T self, std::vector< std::vector< int > >::iterator pos, vector_integer_T x) -> std::vector< std::vector< int > >::iterator\n"
+		"vinteger2d_T_insert(vinteger2d_T self, std::vector< std::vector< int > >::iterator pos, std::vector< std::vector< int > >::size_type n, vector_integer_T x)\n"
 		""},
-	 { "vinteger2d_t_reserve", _wrap_vinteger2d_t_reserve, METH_VARARGS, "vinteger2d_t_reserve(vinteger2d_t self, std::vector< std::vector< int > >::size_type n)"},
-	 { "vinteger2d_t_capacity", _wrap_vinteger2d_t_capacity, METH_O, "vinteger2d_t_capacity(vinteger2d_t self) -> std::vector< std::vector< int > >::size_type"},
-	 { "delete_vinteger2d_t", _wrap_delete_vinteger2d_t, METH_O, "delete_vinteger2d_t(vinteger2d_t self)"},
-	 { "vinteger2d_t_swigregister", vinteger2d_t_swigregister, METH_O, NULL},
-	 { "vinteger2d_t_swiginit", vinteger2d_t_swiginit, METH_VARARGS, NULL},
-	 { "vector_longinteger_t_iterator", _wrap_vector_longinteger_t_iterator, METH_O, "vector_longinteger_t_iterator(vector_longinteger_t self) -> SwigPyIterator"},
-	 { "vector_longinteger_t___nonzero__", _wrap_vector_longinteger_t___nonzero__, METH_O, "vector_longinteger_t___nonzero__(vector_longinteger_t self) -> bool"},
-	 { "vector_longinteger_t___bool__", _wrap_vector_longinteger_t___bool__, METH_O, "vector_longinteger_t___bool__(vector_longinteger_t self) -> bool"},
-	 { "vector_longinteger_t___len__", _wrap_vector_longinteger_t___len__, METH_O, "vector_longinteger_t___len__(vector_longinteger_t self) -> std::vector< unsigned long >::size_type"},
-	 { "vector_longinteger_t___getslice__", _wrap_vector_longinteger_t___getslice__, METH_VARARGS, "vector_longinteger_t___getslice__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j) -> vector_longinteger_t"},
-	 { "vector_longinteger_t___setslice__", _wrap_vector_longinteger_t___setslice__, METH_VARARGS, "\n"
-		"vector_longinteger_t___setslice__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j)\n"
-		"vector_longinteger_t___setslice__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j, vector_longinteger_t v)\n"
+	 { "vinteger2d_T_reserve", _wrap_vinteger2d_T_reserve, METH_VARARGS, "vinteger2d_T_reserve(vinteger2d_T self, std::vector< std::vector< int > >::size_type n)"},
+	 { "vinteger2d_T_capacity", _wrap_vinteger2d_T_capacity, METH_O, "vinteger2d_T_capacity(vinteger2d_T self) -> std::vector< std::vector< int > >::size_type"},
+	 { "delete_vinteger2d_T", _wrap_delete_vinteger2d_T, METH_O, "delete_vinteger2d_T(vinteger2d_T self)"},
+	 { "vinteger2d_T_swigregister", vinteger2d_T_swigregister, METH_O, NULL},
+	 { "vinteger2d_T_swiginit", vinteger2d_T_swiginit, METH_VARARGS, NULL},
+	 { "vector_longinteger_T_iterator", _wrap_vector_longinteger_T_iterator, METH_O, "vector_longinteger_T_iterator(vector_longinteger_T self) -> SwigPyIterator"},
+	 { "vector_longinteger_T___nonzero__", _wrap_vector_longinteger_T___nonzero__, METH_O, "vector_longinteger_T___nonzero__(vector_longinteger_T self) -> bool"},
+	 { "vector_longinteger_T___bool__", _wrap_vector_longinteger_T___bool__, METH_O, "vector_longinteger_T___bool__(vector_longinteger_T self) -> bool"},
+	 { "vector_longinteger_T___len__", _wrap_vector_longinteger_T___len__, METH_O, "vector_longinteger_T___len__(vector_longinteger_T self) -> std::vector< unsigned long >::size_type"},
+	 { "vector_longinteger_T___getslice__", _wrap_vector_longinteger_T___getslice__, METH_VARARGS, "vector_longinteger_T___getslice__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j) -> vector_longinteger_T"},
+	 { "vector_longinteger_T___setslice__", _wrap_vector_longinteger_T___setslice__, METH_VARARGS, "\n"
+		"vector_longinteger_T___setslice__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j)\n"
+		"vector_longinteger_T___setslice__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j, vector_longinteger_T v)\n"
 		""},
-	 { "vector_longinteger_t___delslice__", _wrap_vector_longinteger_t___delslice__, METH_VARARGS, "vector_longinteger_t___delslice__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j)"},
-	 { "vector_longinteger_t___delitem__", _wrap_vector_longinteger_t___delitem__, METH_VARARGS, "\n"
-		"vector_longinteger_t___delitem__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i)\n"
-		"vector_longinteger_t___delitem__(vector_longinteger_t self, SWIGPY_SLICEOBJECT * slice)\n"
+	 { "vector_longinteger_T___delslice__", _wrap_vector_longinteger_T___delslice__, METH_VARARGS, "vector_longinteger_T___delslice__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j)"},
+	 { "vector_longinteger_T___delitem__", _wrap_vector_longinteger_T___delitem__, METH_VARARGS, "\n"
+		"vector_longinteger_T___delitem__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i)\n"
+		"vector_longinteger_T___delitem__(vector_longinteger_T self, SWIGPY_SLICEOBJECT * slice)\n"
 		""},
-	 { "vector_longinteger_t___getitem__", _wrap_vector_longinteger_t___getitem__, METH_VARARGS, "\n"
-		"vector_longinteger_t___getitem__(vector_longinteger_t self, SWIGPY_SLICEOBJECT * slice) -> vector_longinteger_t\n"
-		"vector_longinteger_t___getitem__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i) -> std::vector< unsigned long >::value_type const &\n"
+	 { "vector_longinteger_T___getitem__", _wrap_vector_longinteger_T___getitem__, METH_VARARGS, "\n"
+		"vector_longinteger_T___getitem__(vector_longinteger_T self, SWIGPY_SLICEOBJECT * slice) -> vector_longinteger_T\n"
+		"vector_longinteger_T___getitem__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i) -> std::vector< unsigned long >::value_type const &\n"
 		""},
-	 { "vector_longinteger_t___setitem__", _wrap_vector_longinteger_t___setitem__, METH_VARARGS, "\n"
-		"vector_longinteger_t___setitem__(vector_longinteger_t self, SWIGPY_SLICEOBJECT * slice, vector_longinteger_t v)\n"
-		"vector_longinteger_t___setitem__(vector_longinteger_t self, SWIGPY_SLICEOBJECT * slice)\n"
-		"vector_longinteger_t___setitem__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::value_type const & x)\n"
+	 { "vector_longinteger_T___setitem__", _wrap_vector_longinteger_T___setitem__, METH_VARARGS, "\n"
+		"vector_longinteger_T___setitem__(vector_longinteger_T self, SWIGPY_SLICEOBJECT * slice, vector_longinteger_T v)\n"
+		"vector_longinteger_T___setitem__(vector_longinteger_T self, SWIGPY_SLICEOBJECT * slice)\n"
+		"vector_longinteger_T___setitem__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::value_type const & x)\n"
 		""},
-	 { "vector_longinteger_t_pop", _wrap_vector_longinteger_t_pop, METH_O, "vector_longinteger_t_pop(vector_longinteger_t self) -> std::vector< unsigned long >::value_type"},
-	 { "vector_longinteger_t_append", _wrap_vector_longinteger_t_append, METH_VARARGS, "vector_longinteger_t_append(vector_longinteger_t self, std::vector< unsigned long >::value_type const & x)"},
-	 { "vector_longinteger_t_empty", _wrap_vector_longinteger_t_empty, METH_O, "vector_longinteger_t_empty(vector_longinteger_t self) -> bool"},
-	 { "vector_longinteger_t_size", _wrap_vector_longinteger_t_size, METH_O, "vector_longinteger_t_size(vector_longinteger_t self) -> std::vector< unsigned long >::size_type"},
-	 { "vector_longinteger_t_swap", _wrap_vector_longinteger_t_swap, METH_VARARGS, "vector_longinteger_t_swap(vector_longinteger_t self, vector_longinteger_t v)"},
-	 { "vector_longinteger_t_begin", _wrap_vector_longinteger_t_begin, METH_O, "vector_longinteger_t_begin(vector_longinteger_t self) -> std::vector< unsigned long >::iterator"},
-	 { "vector_longinteger_t_end", _wrap_vector_longinteger_t_end, METH_O, "vector_longinteger_t_end(vector_longinteger_t self) -> std::vector< unsigned long >::iterator"},
-	 { "vector_longinteger_t_rbegin", _wrap_vector_longinteger_t_rbegin, METH_O, "vector_longinteger_t_rbegin(vector_longinteger_t self) -> std::vector< unsigned long >::reverse_iterator"},
-	 { "vector_longinteger_t_rend", _wrap_vector_longinteger_t_rend, METH_O, "vector_longinteger_t_rend(vector_longinteger_t self) -> std::vector< unsigned long >::reverse_iterator"},
-	 { "vector_longinteger_t_clear", _wrap_vector_longinteger_t_clear, METH_O, "vector_longinteger_t_clear(vector_longinteger_t self)"},
-	 { "vector_longinteger_t_get_allocator", _wrap_vector_longinteger_t_get_allocator, METH_O, "vector_longinteger_t_get_allocator(vector_longinteger_t self) -> std::vector< unsigned long >::allocator_type"},
-	 { "vector_longinteger_t_pop_back", _wrap_vector_longinteger_t_pop_back, METH_O, "vector_longinteger_t_pop_back(vector_longinteger_t self)"},
-	 { "vector_longinteger_t_erase", _wrap_vector_longinteger_t_erase, METH_VARARGS, "\n"
-		"vector_longinteger_t_erase(vector_longinteger_t self, std::vector< unsigned long >::iterator pos) -> std::vector< unsigned long >::iterator\n"
-		"vector_longinteger_t_erase(vector_longinteger_t self, std::vector< unsigned long >::iterator first, std::vector< unsigned long >::iterator last) -> std::vector< unsigned long >::iterator\n"
+	 { "vector_longinteger_T_pop", _wrap_vector_longinteger_T_pop, METH_O, "vector_longinteger_T_pop(vector_longinteger_T self) -> std::vector< unsigned long >::value_type"},
+	 { "vector_longinteger_T_append", _wrap_vector_longinteger_T_append, METH_VARARGS, "vector_longinteger_T_append(vector_longinteger_T self, std::vector< unsigned long >::value_type const & x)"},
+	 { "vector_longinteger_T_empty", _wrap_vector_longinteger_T_empty, METH_O, "vector_longinteger_T_empty(vector_longinteger_T self) -> bool"},
+	 { "vector_longinteger_T_size", _wrap_vector_longinteger_T_size, METH_O, "vector_longinteger_T_size(vector_longinteger_T self) -> std::vector< unsigned long >::size_type"},
+	 { "vector_longinteger_T_swap", _wrap_vector_longinteger_T_swap, METH_VARARGS, "vector_longinteger_T_swap(vector_longinteger_T self, vector_longinteger_T v)"},
+	 { "vector_longinteger_T_begin", _wrap_vector_longinteger_T_begin, METH_O, "vector_longinteger_T_begin(vector_longinteger_T self) -> std::vector< unsigned long >::iterator"},
+	 { "vector_longinteger_T_end", _wrap_vector_longinteger_T_end, METH_O, "vector_longinteger_T_end(vector_longinteger_T self) -> std::vector< unsigned long >::iterator"},
+	 { "vector_longinteger_T_rbegin", _wrap_vector_longinteger_T_rbegin, METH_O, "vector_longinteger_T_rbegin(vector_longinteger_T self) -> std::vector< unsigned long >::reverse_iterator"},
+	 { "vector_longinteger_T_rend", _wrap_vector_longinteger_T_rend, METH_O, "vector_longinteger_T_rend(vector_longinteger_T self) -> std::vector< unsigned long >::reverse_iterator"},
+	 { "vector_longinteger_T_clear", _wrap_vector_longinteger_T_clear, METH_O, "vector_longinteger_T_clear(vector_longinteger_T self)"},
+	 { "vector_longinteger_T_get_allocator", _wrap_vector_longinteger_T_get_allocator, METH_O, "vector_longinteger_T_get_allocator(vector_longinteger_T self) -> std::vector< unsigned long >::allocator_type"},
+	 { "vector_longinteger_T_pop_back", _wrap_vector_longinteger_T_pop_back, METH_O, "vector_longinteger_T_pop_back(vector_longinteger_T self)"},
+	 { "vector_longinteger_T_erase", _wrap_vector_longinteger_T_erase, METH_VARARGS, "\n"
+		"vector_longinteger_T_erase(vector_longinteger_T self, std::vector< unsigned long >::iterator pos) -> std::vector< unsigned long >::iterator\n"
+		"vector_longinteger_T_erase(vector_longinteger_T self, std::vector< unsigned long >::iterator first, std::vector< unsigned long >::iterator last) -> std::vector< unsigned long >::iterator\n"
 		""},
-	 { "new_vector_longinteger_t", _wrap_new_vector_longinteger_t, METH_VARARGS, "\n"
-		"vector_longinteger_t()\n"
-		"vector_longinteger_t(vector_longinteger_t other)\n"
-		"vector_longinteger_t(std::vector< unsigned long >::size_type size)\n"
-		"new_vector_longinteger_t(std::vector< unsigned long >::size_type size, std::vector< unsigned long >::value_type const & value) -> vector_longinteger_t\n"
+	 { "new_vector_longinteger_T", _wrap_new_vector_longinteger_T, METH_VARARGS, "\n"
+		"vector_longinteger_T()\n"
+		"vector_longinteger_T(vector_longinteger_T other)\n"
+		"vector_longinteger_T(std::vector< unsigned long >::size_type size)\n"
+		"new_vector_longinteger_T(std::vector< unsigned long >::size_type size, std::vector< unsigned long >::value_type const & value) -> vector_longinteger_T\n"
 		""},
-	 { "vector_longinteger_t_push_back", _wrap_vector_longinteger_t_push_back, METH_VARARGS, "vector_longinteger_t_push_back(vector_longinteger_t self, std::vector< unsigned long >::value_type const & x)"},
-	 { "vector_longinteger_t_front", _wrap_vector_longinteger_t_front, METH_O, "vector_longinteger_t_front(vector_longinteger_t self) -> std::vector< unsigned long >::value_type const &"},
-	 { "vector_longinteger_t_back", _wrap_vector_longinteger_t_back, METH_O, "vector_longinteger_t_back(vector_longinteger_t self) -> std::vector< unsigned long >::value_type const &"},
-	 { "vector_longinteger_t_assign", _wrap_vector_longinteger_t_assign, METH_VARARGS, "vector_longinteger_t_assign(vector_longinteger_t self, std::vector< unsigned long >::size_type n, std::vector< unsigned long >::value_type const & x)"},
-	 { "vector_longinteger_t_resize", _wrap_vector_longinteger_t_resize, METH_VARARGS, "\n"
-		"vector_longinteger_t_resize(vector_longinteger_t self, std::vector< unsigned long >::size_type new_size)\n"
-		"vector_longinteger_t_resize(vector_longinteger_t self, std::vector< unsigned long >::size_type new_size, std::vector< unsigned long >::value_type const & x)\n"
+	 { "vector_longinteger_T_push_back", _wrap_vector_longinteger_T_push_back, METH_VARARGS, "vector_longinteger_T_push_back(vector_longinteger_T self, std::vector< unsigned long >::value_type const & x)"},
+	 { "vector_longinteger_T_front", _wrap_vector_longinteger_T_front, METH_O, "vector_longinteger_T_front(vector_longinteger_T self) -> std::vector< unsigned long >::value_type const &"},
+	 { "vector_longinteger_T_back", _wrap_vector_longinteger_T_back, METH_O, "vector_longinteger_T_back(vector_longinteger_T self) -> std::vector< unsigned long >::value_type const &"},
+	 { "vector_longinteger_T_assign", _wrap_vector_longinteger_T_assign, METH_VARARGS, "vector_longinteger_T_assign(vector_longinteger_T self, std::vector< unsigned long >::size_type n, std::vector< unsigned long >::value_type const & x)"},
+	 { "vector_longinteger_T_resize", _wrap_vector_longinteger_T_resize, METH_VARARGS, "\n"
+		"vector_longinteger_T_resize(vector_longinteger_T self, std::vector< unsigned long >::size_type new_size)\n"
+		"vector_longinteger_T_resize(vector_longinteger_T self, std::vector< unsigned long >::size_type new_size, std::vector< unsigned long >::value_type const & x)\n"
 		""},
-	 { "vector_longinteger_t_insert", _wrap_vector_longinteger_t_insert, METH_VARARGS, "\n"
-		"vector_longinteger_t_insert(vector_longinteger_t self, std::vector< unsigned long >::iterator pos, std::vector< unsigned long >::value_type const & x) -> std::vector< unsigned long >::iterator\n"
-		"vector_longinteger_t_insert(vector_longinteger_t self, std::vector< unsigned long >::iterator pos, std::vector< unsigned long >::size_type n, std::vector< unsigned long >::value_type const & x)\n"
+	 { "vector_longinteger_T_insert", _wrap_vector_longinteger_T_insert, METH_VARARGS, "\n"
+		"vector_longinteger_T_insert(vector_longinteger_T self, std::vector< unsigned long >::iterator pos, std::vector< unsigned long >::value_type const & x) -> std::vector< unsigned long >::iterator\n"
+		"vector_longinteger_T_insert(vector_longinteger_T self, std::vector< unsigned long >::iterator pos, std::vector< unsigned long >::size_type n, std::vector< unsigned long >::value_type const & x)\n"
 		""},
-	 { "vector_longinteger_t_reserve", _wrap_vector_longinteger_t_reserve, METH_VARARGS, "vector_longinteger_t_reserve(vector_longinteger_t self, std::vector< unsigned long >::size_type n)"},
-	 { "vector_longinteger_t_capacity", _wrap_vector_longinteger_t_capacity, METH_O, "vector_longinteger_t_capacity(vector_longinteger_t self) -> std::vector< unsigned long >::size_type"},
-	 { "delete_vector_longinteger_t", _wrap_delete_vector_longinteger_t, METH_O, "delete_vector_longinteger_t(vector_longinteger_t self)"},
-	 { "vector_longinteger_t_swigregister", vector_longinteger_t_swigregister, METH_O, NULL},
-	 { "vector_longinteger_t_swiginit", vector_longinteger_t_swiginit, METH_VARARGS, NULL},
-	 { "vector_complex_t_iterator", _wrap_vector_complex_t_iterator, METH_O, "vector_complex_t_iterator(vector_complex_t self) -> SwigPyIterator"},
-	 { "vector_complex_t___nonzero__", _wrap_vector_complex_t___nonzero__, METH_O, "vector_complex_t___nonzero__(vector_complex_t self) -> bool"},
-	 { "vector_complex_t___bool__", _wrap_vector_complex_t___bool__, METH_O, "vector_complex_t___bool__(vector_complex_t self) -> bool"},
-	 { "vector_complex_t___len__", _wrap_vector_complex_t___len__, METH_O, "vector_complex_t___len__(vector_complex_t self) -> std::vector< std::complex< double > >::size_type"},
-	 { "vector_complex_t___getslice__", _wrap_vector_complex_t___getslice__, METH_VARARGS, "vector_complex_t___getslice__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j) -> vector_complex_t"},
-	 { "vector_complex_t___setslice__", _wrap_vector_complex_t___setslice__, METH_VARARGS, "\n"
-		"vector_complex_t___setslice__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j)\n"
-		"vector_complex_t___setslice__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j, vector_complex_t v)\n"
+	 { "vector_longinteger_T_reserve", _wrap_vector_longinteger_T_reserve, METH_VARARGS, "vector_longinteger_T_reserve(vector_longinteger_T self, std::vector< unsigned long >::size_type n)"},
+	 { "vector_longinteger_T_capacity", _wrap_vector_longinteger_T_capacity, METH_O, "vector_longinteger_T_capacity(vector_longinteger_T self) -> std::vector< unsigned long >::size_type"},
+	 { "delete_vector_longinteger_T", _wrap_delete_vector_longinteger_T, METH_O, "delete_vector_longinteger_T(vector_longinteger_T self)"},
+	 { "vector_longinteger_T_swigregister", vector_longinteger_T_swigregister, METH_O, NULL},
+	 { "vector_longinteger_T_swiginit", vector_longinteger_T_swiginit, METH_VARARGS, NULL},
+	 { "vector_complex_T_iterator", _wrap_vector_complex_T_iterator, METH_O, "vector_complex_T_iterator(vector_complex_T self) -> SwigPyIterator"},
+	 { "vector_complex_T___nonzero__", _wrap_vector_complex_T___nonzero__, METH_O, "vector_complex_T___nonzero__(vector_complex_T self) -> bool"},
+	 { "vector_complex_T___bool__", _wrap_vector_complex_T___bool__, METH_O, "vector_complex_T___bool__(vector_complex_T self) -> bool"},
+	 { "vector_complex_T___len__", _wrap_vector_complex_T___len__, METH_O, "vector_complex_T___len__(vector_complex_T self) -> std::vector< std::complex< double > >::size_type"},
+	 { "vector_complex_T___getslice__", _wrap_vector_complex_T___getslice__, METH_VARARGS, "vector_complex_T___getslice__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j) -> vector_complex_T"},
+	 { "vector_complex_T___setslice__", _wrap_vector_complex_T___setslice__, METH_VARARGS, "\n"
+		"vector_complex_T___setslice__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j)\n"
+		"vector_complex_T___setslice__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j, vector_complex_T v)\n"
 		""},
-	 { "vector_complex_t___delslice__", _wrap_vector_complex_t___delslice__, METH_VARARGS, "vector_complex_t___delslice__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j)"},
-	 { "vector_complex_t___delitem__", _wrap_vector_complex_t___delitem__, METH_VARARGS, "\n"
-		"vector_complex_t___delitem__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i)\n"
-		"vector_complex_t___delitem__(vector_complex_t self, SWIGPY_SLICEOBJECT * slice)\n"
+	 { "vector_complex_T___delslice__", _wrap_vector_complex_T___delslice__, METH_VARARGS, "vector_complex_T___delslice__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j)"},
+	 { "vector_complex_T___delitem__", _wrap_vector_complex_T___delitem__, METH_VARARGS, "\n"
+		"vector_complex_T___delitem__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i)\n"
+		"vector_complex_T___delitem__(vector_complex_T self, SWIGPY_SLICEOBJECT * slice)\n"
 		""},
-	 { "vector_complex_t___getitem__", _wrap_vector_complex_t___getitem__, METH_VARARGS, "\n"
-		"vector_complex_t___getitem__(vector_complex_t self, SWIGPY_SLICEOBJECT * slice) -> vector_complex_t\n"
-		"vector_complex_t___getitem__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i) -> std::vector< std::complex< double > >::value_type const &\n"
+	 { "vector_complex_T___getitem__", _wrap_vector_complex_T___getitem__, METH_VARARGS, "\n"
+		"vector_complex_T___getitem__(vector_complex_T self, SWIGPY_SLICEOBJECT * slice) -> vector_complex_T\n"
+		"vector_complex_T___getitem__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i) -> std::vector< std::complex< double > >::value_type const &\n"
 		""},
-	 { "vector_complex_t___setitem__", _wrap_vector_complex_t___setitem__, METH_VARARGS, "\n"
-		"vector_complex_t___setitem__(vector_complex_t self, SWIGPY_SLICEOBJECT * slice, vector_complex_t v)\n"
-		"vector_complex_t___setitem__(vector_complex_t self, SWIGPY_SLICEOBJECT * slice)\n"
-		"vector_complex_t___setitem__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::value_type const & x)\n"
+	 { "vector_complex_T___setitem__", _wrap_vector_complex_T___setitem__, METH_VARARGS, "\n"
+		"vector_complex_T___setitem__(vector_complex_T self, SWIGPY_SLICEOBJECT * slice, vector_complex_T v)\n"
+		"vector_complex_T___setitem__(vector_complex_T self, SWIGPY_SLICEOBJECT * slice)\n"
+		"vector_complex_T___setitem__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::value_type const & x)\n"
 		""},
-	 { "vector_complex_t_pop", _wrap_vector_complex_t_pop, METH_O, "vector_complex_t_pop(vector_complex_t self) -> std::vector< std::complex< double > >::value_type"},
-	 { "vector_complex_t_append", _wrap_vector_complex_t_append, METH_VARARGS, "vector_complex_t_append(vector_complex_t self, std::vector< std::complex< double > >::value_type const & x)"},
-	 { "vector_complex_t_empty", _wrap_vector_complex_t_empty, METH_O, "vector_complex_t_empty(vector_complex_t self) -> bool"},
-	 { "vector_complex_t_size", _wrap_vector_complex_t_size, METH_O, "vector_complex_t_size(vector_complex_t self) -> std::vector< std::complex< double > >::size_type"},
-	 { "vector_complex_t_swap", _wrap_vector_complex_t_swap, METH_VARARGS, "vector_complex_t_swap(vector_complex_t self, vector_complex_t v)"},
-	 { "vector_complex_t_begin", _wrap_vector_complex_t_begin, METH_O, "vector_complex_t_begin(vector_complex_t self) -> std::vector< std::complex< double > >::iterator"},
-	 { "vector_complex_t_end", _wrap_vector_complex_t_end, METH_O, "vector_complex_t_end(vector_complex_t self) -> std::vector< std::complex< double > >::iterator"},
-	 { "vector_complex_t_rbegin", _wrap_vector_complex_t_rbegin, METH_O, "vector_complex_t_rbegin(vector_complex_t self) -> std::vector< std::complex< double > >::reverse_iterator"},
-	 { "vector_complex_t_rend", _wrap_vector_complex_t_rend, METH_O, "vector_complex_t_rend(vector_complex_t self) -> std::vector< std::complex< double > >::reverse_iterator"},
-	 { "vector_complex_t_clear", _wrap_vector_complex_t_clear, METH_O, "vector_complex_t_clear(vector_complex_t self)"},
-	 { "vector_complex_t_get_allocator", _wrap_vector_complex_t_get_allocator, METH_O, "vector_complex_t_get_allocator(vector_complex_t self) -> std::vector< std::complex< double > >::allocator_type"},
-	 { "vector_complex_t_pop_back", _wrap_vector_complex_t_pop_back, METH_O, "vector_complex_t_pop_back(vector_complex_t self)"},
-	 { "vector_complex_t_erase", _wrap_vector_complex_t_erase, METH_VARARGS, "\n"
-		"vector_complex_t_erase(vector_complex_t self, std::vector< std::complex< double > >::iterator pos) -> std::vector< std::complex< double > >::iterator\n"
-		"vector_complex_t_erase(vector_complex_t self, std::vector< std::complex< double > >::iterator first, std::vector< std::complex< double > >::iterator last) -> std::vector< std::complex< double > >::iterator\n"
+	 { "vector_complex_T_pop", _wrap_vector_complex_T_pop, METH_O, "vector_complex_T_pop(vector_complex_T self) -> std::vector< std::complex< double > >::value_type"},
+	 { "vector_complex_T_append", _wrap_vector_complex_T_append, METH_VARARGS, "vector_complex_T_append(vector_complex_T self, std::vector< std::complex< double > >::value_type const & x)"},
+	 { "vector_complex_T_empty", _wrap_vector_complex_T_empty, METH_O, "vector_complex_T_empty(vector_complex_T self) -> bool"},
+	 { "vector_complex_T_size", _wrap_vector_complex_T_size, METH_O, "vector_complex_T_size(vector_complex_T self) -> std::vector< std::complex< double > >::size_type"},
+	 { "vector_complex_T_swap", _wrap_vector_complex_T_swap, METH_VARARGS, "vector_complex_T_swap(vector_complex_T self, vector_complex_T v)"},
+	 { "vector_complex_T_begin", _wrap_vector_complex_T_begin, METH_O, "vector_complex_T_begin(vector_complex_T self) -> std::vector< std::complex< double > >::iterator"},
+	 { "vector_complex_T_end", _wrap_vector_complex_T_end, METH_O, "vector_complex_T_end(vector_complex_T self) -> std::vector< std::complex< double > >::iterator"},
+	 { "vector_complex_T_rbegin", _wrap_vector_complex_T_rbegin, METH_O, "vector_complex_T_rbegin(vector_complex_T self) -> std::vector< std::complex< double > >::reverse_iterator"},
+	 { "vector_complex_T_rend", _wrap_vector_complex_T_rend, METH_O, "vector_complex_T_rend(vector_complex_T self) -> std::vector< std::complex< double > >::reverse_iterator"},
+	 { "vector_complex_T_clear", _wrap_vector_complex_T_clear, METH_O, "vector_complex_T_clear(vector_complex_T self)"},
+	 { "vector_complex_T_get_allocator", _wrap_vector_complex_T_get_allocator, METH_O, "vector_complex_T_get_allocator(vector_complex_T self) -> std::vector< std::complex< double > >::allocator_type"},
+	 { "vector_complex_T_pop_back", _wrap_vector_complex_T_pop_back, METH_O, "vector_complex_T_pop_back(vector_complex_T self)"},
+	 { "vector_complex_T_erase", _wrap_vector_complex_T_erase, METH_VARARGS, "\n"
+		"vector_complex_T_erase(vector_complex_T self, std::vector< std::complex< double > >::iterator pos) -> std::vector< std::complex< double > >::iterator\n"
+		"vector_complex_T_erase(vector_complex_T self, std::vector< std::complex< double > >::iterator first, std::vector< std::complex< double > >::iterator last) -> std::vector< std::complex< double > >::iterator\n"
 		""},
-	 { "new_vector_complex_t", _wrap_new_vector_complex_t, METH_VARARGS, "\n"
-		"vector_complex_t()\n"
-		"vector_complex_t(vector_complex_t other)\n"
-		"vector_complex_t(std::vector< std::complex< double > >::size_type size)\n"
-		"new_vector_complex_t(std::vector< std::complex< double > >::size_type size, std::vector< std::complex< double > >::value_type const & value) -> vector_complex_t\n"
+	 { "new_vector_complex_T", _wrap_new_vector_complex_T, METH_VARARGS, "\n"
+		"vector_complex_T()\n"
+		"vector_complex_T(vector_complex_T other)\n"
+		"vector_complex_T(std::vector< std::complex< double > >::size_type size)\n"
+		"new_vector_complex_T(std::vector< std::complex< double > >::size_type size, std::vector< std::complex< double > >::value_type const & value) -> vector_complex_T\n"
 		""},
-	 { "vector_complex_t_push_back", _wrap_vector_complex_t_push_back, METH_VARARGS, "vector_complex_t_push_back(vector_complex_t self, std::vector< std::complex< double > >::value_type const & x)"},
-	 { "vector_complex_t_front", _wrap_vector_complex_t_front, METH_O, "vector_complex_t_front(vector_complex_t self) -> std::vector< std::complex< double > >::value_type const &"},
-	 { "vector_complex_t_back", _wrap_vector_complex_t_back, METH_O, "vector_complex_t_back(vector_complex_t self) -> std::vector< std::complex< double > >::value_type const &"},
-	 { "vector_complex_t_assign", _wrap_vector_complex_t_assign, METH_VARARGS, "vector_complex_t_assign(vector_complex_t self, std::vector< std::complex< double > >::size_type n, std::vector< std::complex< double > >::value_type const & x)"},
-	 { "vector_complex_t_resize", _wrap_vector_complex_t_resize, METH_VARARGS, "\n"
-		"vector_complex_t_resize(vector_complex_t self, std::vector< std::complex< double > >::size_type new_size)\n"
-		"vector_complex_t_resize(vector_complex_t self, std::vector< std::complex< double > >::size_type new_size, std::vector< std::complex< double > >::value_type const & x)\n"
+	 { "vector_complex_T_push_back", _wrap_vector_complex_T_push_back, METH_VARARGS, "vector_complex_T_push_back(vector_complex_T self, std::vector< std::complex< double > >::value_type const & x)"},
+	 { "vector_complex_T_front", _wrap_vector_complex_T_front, METH_O, "vector_complex_T_front(vector_complex_T self) -> std::vector< std::complex< double > >::value_type const &"},
+	 { "vector_complex_T_back", _wrap_vector_complex_T_back, METH_O, "vector_complex_T_back(vector_complex_T self) -> std::vector< std::complex< double > >::value_type const &"},
+	 { "vector_complex_T_assign", _wrap_vector_complex_T_assign, METH_VARARGS, "vector_complex_T_assign(vector_complex_T self, std::vector< std::complex< double > >::size_type n, std::vector< std::complex< double > >::value_type const & x)"},
+	 { "vector_complex_T_resize", _wrap_vector_complex_T_resize, METH_VARARGS, "\n"
+		"vector_complex_T_resize(vector_complex_T self, std::vector< std::complex< double > >::size_type new_size)\n"
+		"vector_complex_T_resize(vector_complex_T self, std::vector< std::complex< double > >::size_type new_size, std::vector< std::complex< double > >::value_type const & x)\n"
 		""},
-	 { "vector_complex_t_insert", _wrap_vector_complex_t_insert, METH_VARARGS, "\n"
-		"vector_complex_t_insert(vector_complex_t self, std::vector< std::complex< double > >::iterator pos, std::vector< std::complex< double > >::value_type const & x) -> std::vector< std::complex< double > >::iterator\n"
-		"vector_complex_t_insert(vector_complex_t self, std::vector< std::complex< double > >::iterator pos, std::vector< std::complex< double > >::size_type n, std::vector< std::complex< double > >::value_type const & x)\n"
+	 { "vector_complex_T_insert", _wrap_vector_complex_T_insert, METH_VARARGS, "\n"
+		"vector_complex_T_insert(vector_complex_T self, std::vector< std::complex< double > >::iterator pos, std::vector< std::complex< double > >::value_type const & x) -> std::vector< std::complex< double > >::iterator\n"
+		"vector_complex_T_insert(vector_complex_T self, std::vector< std::complex< double > >::iterator pos, std::vector< std::complex< double > >::size_type n, std::vector< std::complex< double > >::value_type const & x)\n"
 		""},
-	 { "vector_complex_t_reserve", _wrap_vector_complex_t_reserve, METH_VARARGS, "vector_complex_t_reserve(vector_complex_t self, std::vector< std::complex< double > >::size_type n)"},
-	 { "vector_complex_t_capacity", _wrap_vector_complex_t_capacity, METH_O, "vector_complex_t_capacity(vector_complex_t self) -> std::vector< std::complex< double > >::size_type"},
-	 { "delete_vector_complex_t", _wrap_delete_vector_complex_t, METH_O, "delete_vector_complex_t(vector_complex_t self)"},
-	 { "vector_complex_t_swigregister", vector_complex_t_swigregister, METH_O, NULL},
-	 { "vector_complex_t_swiginit", vector_complex_t_swiginit, METH_VARARGS, NULL},
-	 { "vector_string_t_iterator", _wrap_vector_string_t_iterator, METH_O, "vector_string_t_iterator(vector_string_t self) -> SwigPyIterator"},
-	 { "vector_string_t___nonzero__", _wrap_vector_string_t___nonzero__, METH_O, "vector_string_t___nonzero__(vector_string_t self) -> bool"},
-	 { "vector_string_t___bool__", _wrap_vector_string_t___bool__, METH_O, "vector_string_t___bool__(vector_string_t self) -> bool"},
-	 { "vector_string_t___len__", _wrap_vector_string_t___len__, METH_O, "vector_string_t___len__(vector_string_t self) -> std::vector< std::string >::size_type"},
-	 { "vector_string_t___getslice__", _wrap_vector_string_t___getslice__, METH_VARARGS, "vector_string_t___getslice__(vector_string_t self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j) -> vector_string_t"},
-	 { "vector_string_t___setslice__", _wrap_vector_string_t___setslice__, METH_VARARGS, "\n"
-		"vector_string_t___setslice__(vector_string_t self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j)\n"
-		"vector_string_t___setslice__(vector_string_t self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j, vector_string_t v)\n"
+	 { "vector_complex_T_reserve", _wrap_vector_complex_T_reserve, METH_VARARGS, "vector_complex_T_reserve(vector_complex_T self, std::vector< std::complex< double > >::size_type n)"},
+	 { "vector_complex_T_capacity", _wrap_vector_complex_T_capacity, METH_O, "vector_complex_T_capacity(vector_complex_T self) -> std::vector< std::complex< double > >::size_type"},
+	 { "delete_vector_complex_T", _wrap_delete_vector_complex_T, METH_O, "delete_vector_complex_T(vector_complex_T self)"},
+	 { "vector_complex_T_swigregister", vector_complex_T_swigregister, METH_O, NULL},
+	 { "vector_complex_T_swiginit", vector_complex_T_swiginit, METH_VARARGS, NULL},
+	 { "vector_string_T_iterator", _wrap_vector_string_T_iterator, METH_O, "vector_string_T_iterator(vector_string_T self) -> SwigPyIterator"},
+	 { "vector_string_T___nonzero__", _wrap_vector_string_T___nonzero__, METH_O, "vector_string_T___nonzero__(vector_string_T self) -> bool"},
+	 { "vector_string_T___bool__", _wrap_vector_string_T___bool__, METH_O, "vector_string_T___bool__(vector_string_T self) -> bool"},
+	 { "vector_string_T___len__", _wrap_vector_string_T___len__, METH_O, "vector_string_T___len__(vector_string_T self) -> std::vector< std::string >::size_type"},
+	 { "vector_string_T___getslice__", _wrap_vector_string_T___getslice__, METH_VARARGS, "vector_string_T___getslice__(vector_string_T self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j) -> vector_string_T"},
+	 { "vector_string_T___setslice__", _wrap_vector_string_T___setslice__, METH_VARARGS, "\n"
+		"vector_string_T___setslice__(vector_string_T self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j)\n"
+		"vector_string_T___setslice__(vector_string_T self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j, vector_string_T v)\n"
 		""},
-	 { "vector_string_t___delslice__", _wrap_vector_string_t___delslice__, METH_VARARGS, "vector_string_t___delslice__(vector_string_t self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j)"},
-	 { "vector_string_t___delitem__", _wrap_vector_string_t___delitem__, METH_VARARGS, "\n"
-		"vector_string_t___delitem__(vector_string_t self, std::vector< std::string >::difference_type i)\n"
-		"vector_string_t___delitem__(vector_string_t self, SWIGPY_SLICEOBJECT * slice)\n"
+	 { "vector_string_T___delslice__", _wrap_vector_string_T___delslice__, METH_VARARGS, "vector_string_T___delslice__(vector_string_T self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j)"},
+	 { "vector_string_T___delitem__", _wrap_vector_string_T___delitem__, METH_VARARGS, "\n"
+		"vector_string_T___delitem__(vector_string_T self, std::vector< std::string >::difference_type i)\n"
+		"vector_string_T___delitem__(vector_string_T self, SWIGPY_SLICEOBJECT * slice)\n"
 		""},
-	 { "vector_string_t___getitem__", _wrap_vector_string_t___getitem__, METH_VARARGS, "\n"
-		"vector_string_t___getitem__(vector_string_t self, SWIGPY_SLICEOBJECT * slice) -> vector_string_t\n"
-		"vector_string_t___getitem__(vector_string_t self, std::vector< std::string >::difference_type i) -> std::vector< std::string >::value_type const &\n"
+	 { "vector_string_T___getitem__", _wrap_vector_string_T___getitem__, METH_VARARGS, "\n"
+		"vector_string_T___getitem__(vector_string_T self, SWIGPY_SLICEOBJECT * slice) -> vector_string_T\n"
+		"vector_string_T___getitem__(vector_string_T self, std::vector< std::string >::difference_type i) -> std::vector< std::string >::value_type const &\n"
 		""},
-	 { "vector_string_t___setitem__", _wrap_vector_string_t___setitem__, METH_VARARGS, "\n"
-		"vector_string_t___setitem__(vector_string_t self, SWIGPY_SLICEOBJECT * slice, vector_string_t v)\n"
-		"vector_string_t___setitem__(vector_string_t self, SWIGPY_SLICEOBJECT * slice)\n"
-		"vector_string_t___setitem__(vector_string_t self, std::vector< std::string >::difference_type i, std::vector< std::string >::value_type const & x)\n"
+	 { "vector_string_T___setitem__", _wrap_vector_string_T___setitem__, METH_VARARGS, "\n"
+		"vector_string_T___setitem__(vector_string_T self, SWIGPY_SLICEOBJECT * slice, vector_string_T v)\n"
+		"vector_string_T___setitem__(vector_string_T self, SWIGPY_SLICEOBJECT * slice)\n"
+		"vector_string_T___setitem__(vector_string_T self, std::vector< std::string >::difference_type i, std::vector< std::string >::value_type const & x)\n"
 		""},
-	 { "vector_string_t_pop", _wrap_vector_string_t_pop, METH_O, "vector_string_t_pop(vector_string_t self) -> std::vector< std::string >::value_type"},
-	 { "vector_string_t_append", _wrap_vector_string_t_append, METH_VARARGS, "vector_string_t_append(vector_string_t self, std::vector< std::string >::value_type const & x)"},
-	 { "vector_string_t_empty", _wrap_vector_string_t_empty, METH_O, "vector_string_t_empty(vector_string_t self) -> bool"},
-	 { "vector_string_t_size", _wrap_vector_string_t_size, METH_O, "vector_string_t_size(vector_string_t self) -> std::vector< std::string >::size_type"},
-	 { "vector_string_t_swap", _wrap_vector_string_t_swap, METH_VARARGS, "vector_string_t_swap(vector_string_t self, vector_string_t v)"},
-	 { "vector_string_t_begin", _wrap_vector_string_t_begin, METH_O, "vector_string_t_begin(vector_string_t self) -> std::vector< std::string >::iterator"},
-	 { "vector_string_t_end", _wrap_vector_string_t_end, METH_O, "vector_string_t_end(vector_string_t self) -> std::vector< std::string >::iterator"},
-	 { "vector_string_t_rbegin", _wrap_vector_string_t_rbegin, METH_O, "vector_string_t_rbegin(vector_string_t self) -> std::vector< std::string >::reverse_iterator"},
-	 { "vector_string_t_rend", _wrap_vector_string_t_rend, METH_O, "vector_string_t_rend(vector_string_t self) -> std::vector< std::string >::reverse_iterator"},
-	 { "vector_string_t_clear", _wrap_vector_string_t_clear, METH_O, "vector_string_t_clear(vector_string_t self)"},
-	 { "vector_string_t_get_allocator", _wrap_vector_string_t_get_allocator, METH_O, "vector_string_t_get_allocator(vector_string_t self) -> std::vector< std::string >::allocator_type"},
-	 { "vector_string_t_pop_back", _wrap_vector_string_t_pop_back, METH_O, "vector_string_t_pop_back(vector_string_t self)"},
-	 { "vector_string_t_erase", _wrap_vector_string_t_erase, METH_VARARGS, "\n"
-		"vector_string_t_erase(vector_string_t self, std::vector< std::string >::iterator pos) -> std::vector< std::string >::iterator\n"
-		"vector_string_t_erase(vector_string_t self, std::vector< std::string >::iterator first, std::vector< std::string >::iterator last) -> std::vector< std::string >::iterator\n"
+	 { "vector_string_T_pop", _wrap_vector_string_T_pop, METH_O, "vector_string_T_pop(vector_string_T self) -> std::vector< std::string >::value_type"},
+	 { "vector_string_T_append", _wrap_vector_string_T_append, METH_VARARGS, "vector_string_T_append(vector_string_T self, std::vector< std::string >::value_type const & x)"},
+	 { "vector_string_T_empty", _wrap_vector_string_T_empty, METH_O, "vector_string_T_empty(vector_string_T self) -> bool"},
+	 { "vector_string_T_size", _wrap_vector_string_T_size, METH_O, "vector_string_T_size(vector_string_T self) -> std::vector< std::string >::size_type"},
+	 { "vector_string_T_swap", _wrap_vector_string_T_swap, METH_VARARGS, "vector_string_T_swap(vector_string_T self, vector_string_T v)"},
+	 { "vector_string_T_begin", _wrap_vector_string_T_begin, METH_O, "vector_string_T_begin(vector_string_T self) -> std::vector< std::string >::iterator"},
+	 { "vector_string_T_end", _wrap_vector_string_T_end, METH_O, "vector_string_T_end(vector_string_T self) -> std::vector< std::string >::iterator"},
+	 { "vector_string_T_rbegin", _wrap_vector_string_T_rbegin, METH_O, "vector_string_T_rbegin(vector_string_T self) -> std::vector< std::string >::reverse_iterator"},
+	 { "vector_string_T_rend", _wrap_vector_string_T_rend, METH_O, "vector_string_T_rend(vector_string_T self) -> std::vector< std::string >::reverse_iterator"},
+	 { "vector_string_T_clear", _wrap_vector_string_T_clear, METH_O, "vector_string_T_clear(vector_string_T self)"},
+	 { "vector_string_T_get_allocator", _wrap_vector_string_T_get_allocator, METH_O, "vector_string_T_get_allocator(vector_string_T self) -> std::vector< std::string >::allocator_type"},
+	 { "vector_string_T_pop_back", _wrap_vector_string_T_pop_back, METH_O, "vector_string_T_pop_back(vector_string_T self)"},
+	 { "vector_string_T_erase", _wrap_vector_string_T_erase, METH_VARARGS, "\n"
+		"vector_string_T_erase(vector_string_T self, std::vector< std::string >::iterator pos) -> std::vector< std::string >::iterator\n"
+		"vector_string_T_erase(vector_string_T self, std::vector< std::string >::iterator first, std::vector< std::string >::iterator last) -> std::vector< std::string >::iterator\n"
 		""},
-	 { "new_vector_string_t", _wrap_new_vector_string_t, METH_VARARGS, "\n"
-		"vector_string_t()\n"
-		"vector_string_t(vector_string_t other)\n"
-		"vector_string_t(std::vector< std::string >::size_type size)\n"
-		"new_vector_string_t(std::vector< std::string >::size_type size, std::vector< std::string >::value_type const & value) -> vector_string_t\n"
+	 { "new_vector_string_T", _wrap_new_vector_string_T, METH_VARARGS, "\n"
+		"vector_string_T()\n"
+		"vector_string_T(vector_string_T other)\n"
+		"vector_string_T(std::vector< std::string >::size_type size)\n"
+		"new_vector_string_T(std::vector< std::string >::size_type size, std::vector< std::string >::value_type const & value) -> vector_string_T\n"
 		""},
-	 { "vector_string_t_push_back", _wrap_vector_string_t_push_back, METH_VARARGS, "vector_string_t_push_back(vector_string_t self, std::vector< std::string >::value_type const & x)"},
-	 { "vector_string_t_front", _wrap_vector_string_t_front, METH_O, "vector_string_t_front(vector_string_t self) -> std::vector< std::string >::value_type const &"},
-	 { "vector_string_t_back", _wrap_vector_string_t_back, METH_O, "vector_string_t_back(vector_string_t self) -> std::vector< std::string >::value_type const &"},
-	 { "vector_string_t_assign", _wrap_vector_string_t_assign, METH_VARARGS, "vector_string_t_assign(vector_string_t self, std::vector< std::string >::size_type n, std::vector< std::string >::value_type const & x)"},
-	 { "vector_string_t_resize", _wrap_vector_string_t_resize, METH_VARARGS, "\n"
-		"vector_string_t_resize(vector_string_t self, std::vector< std::string >::size_type new_size)\n"
-		"vector_string_t_resize(vector_string_t self, std::vector< std::string >::size_type new_size, std::vector< std::string >::value_type const & x)\n"
+	 { "vector_string_T_push_back", _wrap_vector_string_T_push_back, METH_VARARGS, "vector_string_T_push_back(vector_string_T self, std::vector< std::string >::value_type const & x)"},
+	 { "vector_string_T_front", _wrap_vector_string_T_front, METH_O, "vector_string_T_front(vector_string_T self) -> std::vector< std::string >::value_type const &"},
+	 { "vector_string_T_back", _wrap_vector_string_T_back, METH_O, "vector_string_T_back(vector_string_T self) -> std::vector< std::string >::value_type const &"},
+	 { "vector_string_T_assign", _wrap_vector_string_T_assign, METH_VARARGS, "vector_string_T_assign(vector_string_T self, std::vector< std::string >::size_type n, std::vector< std::string >::value_type const & x)"},
+	 { "vector_string_T_resize", _wrap_vector_string_T_resize, METH_VARARGS, "\n"
+		"vector_string_T_resize(vector_string_T self, std::vector< std::string >::size_type new_size)\n"
+		"vector_string_T_resize(vector_string_T self, std::vector< std::string >::size_type new_size, std::vector< std::string >::value_type const & x)\n"
 		""},
-	 { "vector_string_t_insert", _wrap_vector_string_t_insert, METH_VARARGS, "\n"
-		"vector_string_t_insert(vector_string_t self, std::vector< std::string >::iterator pos, std::vector< std::string >::value_type const & x) -> std::vector< std::string >::iterator\n"
-		"vector_string_t_insert(vector_string_t self, std::vector< std::string >::iterator pos, std::vector< std::string >::size_type n, std::vector< std::string >::value_type const & x)\n"
+	 { "vector_string_T_insert", _wrap_vector_string_T_insert, METH_VARARGS, "\n"
+		"vector_string_T_insert(vector_string_T self, std::vector< std::string >::iterator pos, std::vector< std::string >::value_type const & x) -> std::vector< std::string >::iterator\n"
+		"vector_string_T_insert(vector_string_T self, std::vector< std::string >::iterator pos, std::vector< std::string >::size_type n, std::vector< std::string >::value_type const & x)\n"
 		""},
-	 { "vector_string_t_reserve", _wrap_vector_string_t_reserve, METH_VARARGS, "vector_string_t_reserve(vector_string_t self, std::vector< std::string >::size_type n)"},
-	 { "vector_string_t_capacity", _wrap_vector_string_t_capacity, METH_O, "vector_string_t_capacity(vector_string_t self) -> std::vector< std::string >::size_type"},
-	 { "delete_vector_string_t", _wrap_delete_vector_string_t, METH_O, "delete_vector_string_t(vector_string_t self)"},
-	 { "vector_string_t_swigregister", vector_string_t_swigregister, METH_O, NULL},
-	 { "vector_string_t_swiginit", vector_string_t_swiginit, METH_VARARGS, NULL},
-	 { "map_string_double_t_iterator", _wrap_map_string_double_t_iterator, METH_O, "map_string_double_t_iterator(map_string_double_t self) -> SwigPyIterator"},
-	 { "map_string_double_t___nonzero__", _wrap_map_string_double_t___nonzero__, METH_O, "map_string_double_t___nonzero__(map_string_double_t self) -> bool"},
-	 { "map_string_double_t___bool__", _wrap_map_string_double_t___bool__, METH_O, "map_string_double_t___bool__(map_string_double_t self) -> bool"},
-	 { "map_string_double_t___len__", _wrap_map_string_double_t___len__, METH_O, "map_string_double_t___len__(map_string_double_t self) -> std::map< std::string,double >::size_type"},
-	 { "map_string_double_t___getitem__", _wrap_map_string_double_t___getitem__, METH_VARARGS, "map_string_double_t___getitem__(map_string_double_t self, std::map< std::string,double >::key_type const & key) -> std::map< std::string,double >::mapped_type const &"},
-	 { "map_string_double_t___delitem__", _wrap_map_string_double_t___delitem__, METH_VARARGS, "map_string_double_t___delitem__(map_string_double_t self, std::map< std::string,double >::key_type const & key)"},
-	 { "map_string_double_t_has_key", _wrap_map_string_double_t_has_key, METH_VARARGS, "map_string_double_t_has_key(map_string_double_t self, std::map< std::string,double >::key_type const & key) -> bool"},
-	 { "map_string_double_t_keys", _wrap_map_string_double_t_keys, METH_O, "map_string_double_t_keys(map_string_double_t self) -> PyObject *"},
-	 { "map_string_double_t_values", _wrap_map_string_double_t_values, METH_O, "map_string_double_t_values(map_string_double_t self) -> PyObject *"},
-	 { "map_string_double_t_items", _wrap_map_string_double_t_items, METH_O, "map_string_double_t_items(map_string_double_t self) -> PyObject *"},
-	 { "map_string_double_t___contains__", _wrap_map_string_double_t___contains__, METH_VARARGS, "map_string_double_t___contains__(map_string_double_t self, std::map< std::string,double >::key_type const & key) -> bool"},
-	 { "map_string_double_t_key_iterator", _wrap_map_string_double_t_key_iterator, METH_O, "map_string_double_t_key_iterator(map_string_double_t self) -> SwigPyIterator"},
-	 { "map_string_double_t_value_iterator", _wrap_map_string_double_t_value_iterator, METH_O, "map_string_double_t_value_iterator(map_string_double_t self) -> SwigPyIterator"},
-	 { "map_string_double_t___setitem__", _wrap_map_string_double_t___setitem__, METH_VARARGS, "\n"
-		"map_string_double_t___setitem__(map_string_double_t self, std::map< std::string,double >::key_type const & key)\n"
-		"map_string_double_t___setitem__(map_string_double_t self, std::map< std::string,double >::key_type const & key, std::map< std::string,double >::mapped_type const & x)\n"
+	 { "vector_string_T_reserve", _wrap_vector_string_T_reserve, METH_VARARGS, "vector_string_T_reserve(vector_string_T self, std::vector< std::string >::size_type n)"},
+	 { "vector_string_T_capacity", _wrap_vector_string_T_capacity, METH_O, "vector_string_T_capacity(vector_string_T self) -> std::vector< std::string >::size_type"},
+	 { "delete_vector_string_T", _wrap_delete_vector_string_T, METH_O, "delete_vector_string_T(vector_string_T self)"},
+	 { "vector_string_T_swigregister", vector_string_T_swigregister, METH_O, NULL},
+	 { "vector_string_T_swiginit", vector_string_T_swiginit, METH_VARARGS, NULL},
+	 { "map_string_double_T_iterator", _wrap_map_string_double_T_iterator, METH_O, "map_string_double_T_iterator(map_string_double_T self) -> SwigPyIterator"},
+	 { "map_string_double_T___nonzero__", _wrap_map_string_double_T___nonzero__, METH_O, "map_string_double_T___nonzero__(map_string_double_T self) -> bool"},
+	 { "map_string_double_T___bool__", _wrap_map_string_double_T___bool__, METH_O, "map_string_double_T___bool__(map_string_double_T self) -> bool"},
+	 { "map_string_double_T___len__", _wrap_map_string_double_T___len__, METH_O, "map_string_double_T___len__(map_string_double_T self) -> std::map< std::string,double >::size_type"},
+	 { "map_string_double_T___getitem__", _wrap_map_string_double_T___getitem__, METH_VARARGS, "map_string_double_T___getitem__(map_string_double_T self, std::map< std::string,double >::key_type const & key) -> std::map< std::string,double >::mapped_type const &"},
+	 { "map_string_double_T___delitem__", _wrap_map_string_double_T___delitem__, METH_VARARGS, "map_string_double_T___delitem__(map_string_double_T self, std::map< std::string,double >::key_type const & key)"},
+	 { "map_string_double_T_has_key", _wrap_map_string_double_T_has_key, METH_VARARGS, "map_string_double_T_has_key(map_string_double_T self, std::map< std::string,double >::key_type const & key) -> bool"},
+	 { "map_string_double_T_keys", _wrap_map_string_double_T_keys, METH_O, "map_string_double_T_keys(map_string_double_T self) -> PyObject *"},
+	 { "map_string_double_T_values", _wrap_map_string_double_T_values, METH_O, "map_string_double_T_values(map_string_double_T self) -> PyObject *"},
+	 { "map_string_double_T_items", _wrap_map_string_double_T_items, METH_O, "map_string_double_T_items(map_string_double_T self) -> PyObject *"},
+	 { "map_string_double_T___contains__", _wrap_map_string_double_T___contains__, METH_VARARGS, "map_string_double_T___contains__(map_string_double_T self, std::map< std::string,double >::key_type const & key) -> bool"},
+	 { "map_string_double_T_key_iterator", _wrap_map_string_double_T_key_iterator, METH_O, "map_string_double_T_key_iterator(map_string_double_T self) -> SwigPyIterator"},
+	 { "map_string_double_T_value_iterator", _wrap_map_string_double_T_value_iterator, METH_O, "map_string_double_T_value_iterator(map_string_double_T self) -> SwigPyIterator"},
+	 { "map_string_double_T___setitem__", _wrap_map_string_double_T___setitem__, METH_VARARGS, "\n"
+		"map_string_double_T___setitem__(map_string_double_T self, std::map< std::string,double >::key_type const & key)\n"
+		"map_string_double_T___setitem__(map_string_double_T self, std::map< std::string,double >::key_type const & key, std::map< std::string,double >::mapped_type const & x)\n"
 		""},
-	 { "map_string_double_t_asdict", _wrap_map_string_double_t_asdict, METH_O, "map_string_double_t_asdict(map_string_double_t self) -> PyObject *"},
-	 { "new_map_string_double_t", _wrap_new_map_string_double_t, METH_VARARGS, "\n"
-		"map_string_double_t(std::less< std::string > const & other)\n"
-		"map_string_double_t()\n"
-		"new_map_string_double_t(map_string_double_t other) -> map_string_double_t\n"
+	 { "map_string_double_T_asdict", _wrap_map_string_double_T_asdict, METH_O, "map_string_double_T_asdict(map_string_double_T self) -> PyObject *"},
+	 { "new_map_string_double_T", _wrap_new_map_string_double_T, METH_VARARGS, "\n"
+		"map_string_double_T(std::less< std::string > const & other)\n"
+		"map_string_double_T()\n"
+		"new_map_string_double_T(map_string_double_T other) -> map_string_double_T\n"
 		""},
-	 { "map_string_double_t_empty", _wrap_map_string_double_t_empty, METH_O, "map_string_double_t_empty(map_string_double_t self) -> bool"},
-	 { "map_string_double_t_size", _wrap_map_string_double_t_size, METH_O, "map_string_double_t_size(map_string_double_t self) -> std::map< std::string,double >::size_type"},
-	 { "map_string_double_t_swap", _wrap_map_string_double_t_swap, METH_VARARGS, "map_string_double_t_swap(map_string_double_t self, map_string_double_t v)"},
-	 { "map_string_double_t_begin", _wrap_map_string_double_t_begin, METH_O, "map_string_double_t_begin(map_string_double_t self) -> std::map< std::string,double >::iterator"},
-	 { "map_string_double_t_end", _wrap_map_string_double_t_end, METH_O, "map_string_double_t_end(map_string_double_t self) -> std::map< std::string,double >::iterator"},
-	 { "map_string_double_t_rbegin", _wrap_map_string_double_t_rbegin, METH_O, "map_string_double_t_rbegin(map_string_double_t self) -> std::map< std::string,double >::reverse_iterator"},
-	 { "map_string_double_t_rend", _wrap_map_string_double_t_rend, METH_O, "map_string_double_t_rend(map_string_double_t self) -> std::map< std::string,double >::reverse_iterator"},
-	 { "map_string_double_t_clear", _wrap_map_string_double_t_clear, METH_O, "map_string_double_t_clear(map_string_double_t self)"},
-	 { "map_string_double_t_get_allocator", _wrap_map_string_double_t_get_allocator, METH_O, "map_string_double_t_get_allocator(map_string_double_t self) -> std::map< std::string,double >::allocator_type"},
-	 { "map_string_double_t_count", _wrap_map_string_double_t_count, METH_VARARGS, "map_string_double_t_count(map_string_double_t self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::size_type"},
-	 { "map_string_double_t_erase", _wrap_map_string_double_t_erase, METH_VARARGS, "\n"
-		"map_string_double_t_erase(map_string_double_t self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::size_type\n"
-		"map_string_double_t_erase(map_string_double_t self, std::map< std::string,double >::iterator position)\n"
-		"map_string_double_t_erase(map_string_double_t self, std::map< std::string,double >::iterator first, std::map< std::string,double >::iterator last)\n"
+	 { "map_string_double_T_empty", _wrap_map_string_double_T_empty, METH_O, "map_string_double_T_empty(map_string_double_T self) -> bool"},
+	 { "map_string_double_T_size", _wrap_map_string_double_T_size, METH_O, "map_string_double_T_size(map_string_double_T self) -> std::map< std::string,double >::size_type"},
+	 { "map_string_double_T_swap", _wrap_map_string_double_T_swap, METH_VARARGS, "map_string_double_T_swap(map_string_double_T self, map_string_double_T v)"},
+	 { "map_string_double_T_begin", _wrap_map_string_double_T_begin, METH_O, "map_string_double_T_begin(map_string_double_T self) -> std::map< std::string,double >::iterator"},
+	 { "map_string_double_T_end", _wrap_map_string_double_T_end, METH_O, "map_string_double_T_end(map_string_double_T self) -> std::map< std::string,double >::iterator"},
+	 { "map_string_double_T_rbegin", _wrap_map_string_double_T_rbegin, METH_O, "map_string_double_T_rbegin(map_string_double_T self) -> std::map< std::string,double >::reverse_iterator"},
+	 { "map_string_double_T_rend", _wrap_map_string_double_T_rend, METH_O, "map_string_double_T_rend(map_string_double_T self) -> std::map< std::string,double >::reverse_iterator"},
+	 { "map_string_double_T_clear", _wrap_map_string_double_T_clear, METH_O, "map_string_double_T_clear(map_string_double_T self)"},
+	 { "map_string_double_T_get_allocator", _wrap_map_string_double_T_get_allocator, METH_O, "map_string_double_T_get_allocator(map_string_double_T self) -> std::map< std::string,double >::allocator_type"},
+	 { "map_string_double_T_count", _wrap_map_string_double_T_count, METH_VARARGS, "map_string_double_T_count(map_string_double_T self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::size_type"},
+	 { "map_string_double_T_erase", _wrap_map_string_double_T_erase, METH_VARARGS, "\n"
+		"map_string_double_T_erase(map_string_double_T self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::size_type\n"
+		"map_string_double_T_erase(map_string_double_T self, std::map< std::string,double >::iterator position)\n"
+		"map_string_double_T_erase(map_string_double_T self, std::map< std::string,double >::iterator first, std::map< std::string,double >::iterator last)\n"
 		""},
-	 { "map_string_double_t_find", _wrap_map_string_double_t_find, METH_VARARGS, "map_string_double_t_find(map_string_double_t self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"},
-	 { "map_string_double_t_lower_bound", _wrap_map_string_double_t_lower_bound, METH_VARARGS, "map_string_double_t_lower_bound(map_string_double_t self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"},
-	 { "map_string_double_t_upper_bound", _wrap_map_string_double_t_upper_bound, METH_VARARGS, "map_string_double_t_upper_bound(map_string_double_t self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"},
-	 { "delete_map_string_double_t", _wrap_delete_map_string_double_t, METH_O, "delete_map_string_double_t(map_string_double_t self)"},
-	 { "map_string_double_t_swigregister", map_string_double_t_swigregister, METH_O, NULL},
-	 { "map_string_double_t_swiginit", map_string_double_t_swiginit, METH_VARARGS, NULL},
-	 { "new_pvacuum_double_t", _wrap_new_pvacuum_double_t, METH_VARARGS, "\n"
-		"pvacuum_double_t()\n"
-		"pvacuum_double_t(double first, double second)\n"
-		"new_pvacuum_double_t(pvacuum_double_t other) -> pvacuum_double_t\n"
+	 { "map_string_double_T_find", _wrap_map_string_double_T_find, METH_VARARGS, "map_string_double_T_find(map_string_double_T self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"},
+	 { "map_string_double_T_lower_bound", _wrap_map_string_double_T_lower_bound, METH_VARARGS, "map_string_double_T_lower_bound(map_string_double_T self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"},
+	 { "map_string_double_T_upper_bound", _wrap_map_string_double_T_upper_bound, METH_VARARGS, "map_string_double_T_upper_bound(map_string_double_T self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"},
+	 { "delete_map_string_double_T", _wrap_delete_map_string_double_T, METH_O, "delete_map_string_double_T(map_string_double_T self)"},
+	 { "map_string_double_T_swigregister", map_string_double_T_swigregister, METH_O, NULL},
+	 { "map_string_double_T_swiginit", map_string_double_T_swiginit, METH_VARARGS, NULL},
+	 { "new_pvacuum_double_T", _wrap_new_pvacuum_double_T, METH_VARARGS, "\n"
+		"pvacuum_double_T()\n"
+		"pvacuum_double_T(double first, double second)\n"
+		"new_pvacuum_double_T(pvacuum_double_T other) -> pvacuum_double_T\n"
 		""},
-	 { "pvacuum_double_t_first_set", _wrap_pvacuum_double_t_first_set, METH_VARARGS, "pvacuum_double_t_first_set(pvacuum_double_t self, double first)"},
-	 { "pvacuum_double_t_first_get", _wrap_pvacuum_double_t_first_get, METH_O, "pvacuum_double_t_first_get(pvacuum_double_t self) -> double"},
-	 { "pvacuum_double_t_second_set", _wrap_pvacuum_double_t_second_set, METH_VARARGS, "pvacuum_double_t_second_set(pvacuum_double_t self, double second)"},
-	 { "pvacuum_double_t_second_get", _wrap_pvacuum_double_t_second_get, METH_O, "pvacuum_double_t_second_get(pvacuum_double_t self) -> double"},
-	 { "delete_pvacuum_double_t", _wrap_delete_pvacuum_double_t, METH_O, "delete_pvacuum_double_t(pvacuum_double_t self)"},
-	 { "pvacuum_double_t_swigregister", pvacuum_double_t_swigregister, METH_O, NULL},
-	 { "pvacuum_double_t_swiginit", pvacuum_double_t_swiginit, METH_VARARGS, NULL},
-	 { "vector_pvacuum_double_t_iterator", _wrap_vector_pvacuum_double_t_iterator, METH_O, "vector_pvacuum_double_t_iterator(vector_pvacuum_double_t self) -> SwigPyIterator"},
-	 { "vector_pvacuum_double_t___nonzero__", _wrap_vector_pvacuum_double_t___nonzero__, METH_O, "vector_pvacuum_double_t___nonzero__(vector_pvacuum_double_t self) -> bool"},
-	 { "vector_pvacuum_double_t___bool__", _wrap_vector_pvacuum_double_t___bool__, METH_O, "vector_pvacuum_double_t___bool__(vector_pvacuum_double_t self) -> bool"},
-	 { "vector_pvacuum_double_t___len__", _wrap_vector_pvacuum_double_t___len__, METH_O, "vector_pvacuum_double_t___len__(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::size_type"},
-	 { "vector_pvacuum_double_t___getslice__", _wrap_vector_pvacuum_double_t___getslice__, METH_VARARGS, "vector_pvacuum_double_t___getslice__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j) -> vector_pvacuum_double_t"},
-	 { "vector_pvacuum_double_t___setslice__", _wrap_vector_pvacuum_double_t___setslice__, METH_VARARGS, "\n"
-		"vector_pvacuum_double_t___setslice__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j)\n"
-		"vector_pvacuum_double_t___setslice__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j, vector_pvacuum_double_t v)\n"
+	 { "pvacuum_double_T_first_set", _wrap_pvacuum_double_T_first_set, METH_VARARGS, "pvacuum_double_T_first_set(pvacuum_double_T self, double first)"},
+	 { "pvacuum_double_T_first_get", _wrap_pvacuum_double_T_first_get, METH_O, "pvacuum_double_T_first_get(pvacuum_double_T self) -> double"},
+	 { "pvacuum_double_T_second_set", _wrap_pvacuum_double_T_second_set, METH_VARARGS, "pvacuum_double_T_second_set(pvacuum_double_T self, double second)"},
+	 { "pvacuum_double_T_second_get", _wrap_pvacuum_double_T_second_get, METH_O, "pvacuum_double_T_second_get(pvacuum_double_T self) -> double"},
+	 { "delete_pvacuum_double_T", _wrap_delete_pvacuum_double_T, METH_O, "delete_pvacuum_double_T(pvacuum_double_T self)"},
+	 { "pvacuum_double_T_swigregister", pvacuum_double_T_swigregister, METH_O, NULL},
+	 { "pvacuum_double_T_swiginit", pvacuum_double_T_swiginit, METH_VARARGS, NULL},
+	 { "vector_pvacuum_double_T_iterator", _wrap_vector_pvacuum_double_T_iterator, METH_O, "vector_pvacuum_double_T_iterator(vector_pvacuum_double_T self) -> SwigPyIterator"},
+	 { "vector_pvacuum_double_T___nonzero__", _wrap_vector_pvacuum_double_T___nonzero__, METH_O, "vector_pvacuum_double_T___nonzero__(vector_pvacuum_double_T self) -> bool"},
+	 { "vector_pvacuum_double_T___bool__", _wrap_vector_pvacuum_double_T___bool__, METH_O, "vector_pvacuum_double_T___bool__(vector_pvacuum_double_T self) -> bool"},
+	 { "vector_pvacuum_double_T___len__", _wrap_vector_pvacuum_double_T___len__, METH_O, "vector_pvacuum_double_T___len__(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::size_type"},
+	 { "vector_pvacuum_double_T___getslice__", _wrap_vector_pvacuum_double_T___getslice__, METH_VARARGS, "vector_pvacuum_double_T___getslice__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j) -> vector_pvacuum_double_T"},
+	 { "vector_pvacuum_double_T___setslice__", _wrap_vector_pvacuum_double_T___setslice__, METH_VARARGS, "\n"
+		"vector_pvacuum_double_T___setslice__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j)\n"
+		"vector_pvacuum_double_T___setslice__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j, vector_pvacuum_double_T v)\n"
 		""},
-	 { "vector_pvacuum_double_t___delslice__", _wrap_vector_pvacuum_double_t___delslice__, METH_VARARGS, "vector_pvacuum_double_t___delslice__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j)"},
-	 { "vector_pvacuum_double_t___delitem__", _wrap_vector_pvacuum_double_t___delitem__, METH_VARARGS, "\n"
-		"vector_pvacuum_double_t___delitem__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i)\n"
-		"vector_pvacuum_double_t___delitem__(vector_pvacuum_double_t self, SWIGPY_SLICEOBJECT * slice)\n"
+	 { "vector_pvacuum_double_T___delslice__", _wrap_vector_pvacuum_double_T___delslice__, METH_VARARGS, "vector_pvacuum_double_T___delslice__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j)"},
+	 { "vector_pvacuum_double_T___delitem__", _wrap_vector_pvacuum_double_T___delitem__, METH_VARARGS, "\n"
+		"vector_pvacuum_double_T___delitem__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i)\n"
+		"vector_pvacuum_double_T___delitem__(vector_pvacuum_double_T self, SWIGPY_SLICEOBJECT * slice)\n"
 		""},
-	 { "vector_pvacuum_double_t___getitem__", _wrap_vector_pvacuum_double_t___getitem__, METH_VARARGS, "\n"
-		"vector_pvacuum_double_t___getitem__(vector_pvacuum_double_t self, SWIGPY_SLICEOBJECT * slice) -> vector_pvacuum_double_t\n"
-		"vector_pvacuum_double_t___getitem__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i) -> pvacuum_double_t\n"
+	 { "vector_pvacuum_double_T___getitem__", _wrap_vector_pvacuum_double_T___getitem__, METH_VARARGS, "\n"
+		"vector_pvacuum_double_T___getitem__(vector_pvacuum_double_T self, SWIGPY_SLICEOBJECT * slice) -> vector_pvacuum_double_T\n"
+		"vector_pvacuum_double_T___getitem__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i) -> pvacuum_double_T\n"
 		""},
-	 { "vector_pvacuum_double_t___setitem__", _wrap_vector_pvacuum_double_t___setitem__, METH_VARARGS, "\n"
-		"vector_pvacuum_double_t___setitem__(vector_pvacuum_double_t self, SWIGPY_SLICEOBJECT * slice, vector_pvacuum_double_t v)\n"
-		"vector_pvacuum_double_t___setitem__(vector_pvacuum_double_t self, SWIGPY_SLICEOBJECT * slice)\n"
-		"vector_pvacuum_double_t___setitem__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i, pvacuum_double_t x)\n"
+	 { "vector_pvacuum_double_T___setitem__", _wrap_vector_pvacuum_double_T___setitem__, METH_VARARGS, "\n"
+		"vector_pvacuum_double_T___setitem__(vector_pvacuum_double_T self, SWIGPY_SLICEOBJECT * slice, vector_pvacuum_double_T v)\n"
+		"vector_pvacuum_double_T___setitem__(vector_pvacuum_double_T self, SWIGPY_SLICEOBJECT * slice)\n"
+		"vector_pvacuum_double_T___setitem__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i, pvacuum_double_T x)\n"
 		""},
-	 { "vector_pvacuum_double_t_pop", _wrap_vector_pvacuum_double_t_pop, METH_O, "vector_pvacuum_double_t_pop(vector_pvacuum_double_t self) -> pvacuum_double_t"},
-	 { "vector_pvacuum_double_t_append", _wrap_vector_pvacuum_double_t_append, METH_VARARGS, "vector_pvacuum_double_t_append(vector_pvacuum_double_t self, pvacuum_double_t x)"},
-	 { "vector_pvacuum_double_t_empty", _wrap_vector_pvacuum_double_t_empty, METH_O, "vector_pvacuum_double_t_empty(vector_pvacuum_double_t self) -> bool"},
-	 { "vector_pvacuum_double_t_size", _wrap_vector_pvacuum_double_t_size, METH_O, "vector_pvacuum_double_t_size(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::size_type"},
-	 { "vector_pvacuum_double_t_swap", _wrap_vector_pvacuum_double_t_swap, METH_VARARGS, "vector_pvacuum_double_t_swap(vector_pvacuum_double_t self, vector_pvacuum_double_t v)"},
-	 { "vector_pvacuum_double_t_begin", _wrap_vector_pvacuum_double_t_begin, METH_O, "vector_pvacuum_double_t_begin(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::iterator"},
-	 { "vector_pvacuum_double_t_end", _wrap_vector_pvacuum_double_t_end, METH_O, "vector_pvacuum_double_t_end(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::iterator"},
-	 { "vector_pvacuum_double_t_rbegin", _wrap_vector_pvacuum_double_t_rbegin, METH_O, "vector_pvacuum_double_t_rbegin(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::reverse_iterator"},
-	 { "vector_pvacuum_double_t_rend", _wrap_vector_pvacuum_double_t_rend, METH_O, "vector_pvacuum_double_t_rend(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::reverse_iterator"},
-	 { "vector_pvacuum_double_t_clear", _wrap_vector_pvacuum_double_t_clear, METH_O, "vector_pvacuum_double_t_clear(vector_pvacuum_double_t self)"},
-	 { "vector_pvacuum_double_t_get_allocator", _wrap_vector_pvacuum_double_t_get_allocator, METH_O, "vector_pvacuum_double_t_get_allocator(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::allocator_type"},
-	 { "vector_pvacuum_double_t_pop_back", _wrap_vector_pvacuum_double_t_pop_back, METH_O, "vector_pvacuum_double_t_pop_back(vector_pvacuum_double_t self)"},
-	 { "vector_pvacuum_double_t_erase", _wrap_vector_pvacuum_double_t_erase, METH_VARARGS, "\n"
-		"vector_pvacuum_double_t_erase(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::iterator pos) -> std::vector< std::pair< double,double > >::iterator\n"
-		"vector_pvacuum_double_t_erase(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::iterator first, std::vector< std::pair< double,double > >::iterator last) -> std::vector< std::pair< double,double > >::iterator\n"
+	 { "vector_pvacuum_double_T_pop", _wrap_vector_pvacuum_double_T_pop, METH_O, "vector_pvacuum_double_T_pop(vector_pvacuum_double_T self) -> pvacuum_double_T"},
+	 { "vector_pvacuum_double_T_append", _wrap_vector_pvacuum_double_T_append, METH_VARARGS, "vector_pvacuum_double_T_append(vector_pvacuum_double_T self, pvacuum_double_T x)"},
+	 { "vector_pvacuum_double_T_empty", _wrap_vector_pvacuum_double_T_empty, METH_O, "vector_pvacuum_double_T_empty(vector_pvacuum_double_T self) -> bool"},
+	 { "vector_pvacuum_double_T_size", _wrap_vector_pvacuum_double_T_size, METH_O, "vector_pvacuum_double_T_size(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::size_type"},
+	 { "vector_pvacuum_double_T_swap", _wrap_vector_pvacuum_double_T_swap, METH_VARARGS, "vector_pvacuum_double_T_swap(vector_pvacuum_double_T self, vector_pvacuum_double_T v)"},
+	 { "vector_pvacuum_double_T_begin", _wrap_vector_pvacuum_double_T_begin, METH_O, "vector_pvacuum_double_T_begin(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::iterator"},
+	 { "vector_pvacuum_double_T_end", _wrap_vector_pvacuum_double_T_end, METH_O, "vector_pvacuum_double_T_end(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::iterator"},
+	 { "vector_pvacuum_double_T_rbegin", _wrap_vector_pvacuum_double_T_rbegin, METH_O, "vector_pvacuum_double_T_rbegin(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::reverse_iterator"},
+	 { "vector_pvacuum_double_T_rend", _wrap_vector_pvacuum_double_T_rend, METH_O, "vector_pvacuum_double_T_rend(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::reverse_iterator"},
+	 { "vector_pvacuum_double_T_clear", _wrap_vector_pvacuum_double_T_clear, METH_O, "vector_pvacuum_double_T_clear(vector_pvacuum_double_T self)"},
+	 { "vector_pvacuum_double_T_get_allocator", _wrap_vector_pvacuum_double_T_get_allocator, METH_O, "vector_pvacuum_double_T_get_allocator(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::allocator_type"},
+	 { "vector_pvacuum_double_T_pop_back", _wrap_vector_pvacuum_double_T_pop_back, METH_O, "vector_pvacuum_double_T_pop_back(vector_pvacuum_double_T self)"},
+	 { "vector_pvacuum_double_T_erase", _wrap_vector_pvacuum_double_T_erase, METH_VARARGS, "\n"
+		"vector_pvacuum_double_T_erase(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::iterator pos) -> std::vector< std::pair< double,double > >::iterator\n"
+		"vector_pvacuum_double_T_erase(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::iterator first, std::vector< std::pair< double,double > >::iterator last) -> std::vector< std::pair< double,double > >::iterator\n"
 		""},
-	 { "new_vector_pvacuum_double_t", _wrap_new_vector_pvacuum_double_t, METH_VARARGS, "\n"
-		"vector_pvacuum_double_t()\n"
-		"vector_pvacuum_double_t(vector_pvacuum_double_t other)\n"
-		"vector_pvacuum_double_t(std::vector< std::pair< double,double > >::size_type size)\n"
-		"new_vector_pvacuum_double_t(std::vector< std::pair< double,double > >::size_type size, pvacuum_double_t value) -> vector_pvacuum_double_t\n"
+	 { "new_vector_pvacuum_double_T", _wrap_new_vector_pvacuum_double_T, METH_VARARGS, "\n"
+		"vector_pvacuum_double_T()\n"
+		"vector_pvacuum_double_T(vector_pvacuum_double_T other)\n"
+		"vector_pvacuum_double_T(std::vector< std::pair< double,double > >::size_type size)\n"
+		"new_vector_pvacuum_double_T(std::vector< std::pair< double,double > >::size_type size, pvacuum_double_T value) -> vector_pvacuum_double_T\n"
 		""},
-	 { "vector_pvacuum_double_t_push_back", _wrap_vector_pvacuum_double_t_push_back, METH_VARARGS, "vector_pvacuum_double_t_push_back(vector_pvacuum_double_t self, pvacuum_double_t x)"},
-	 { "vector_pvacuum_double_t_front", _wrap_vector_pvacuum_double_t_front, METH_O, "vector_pvacuum_double_t_front(vector_pvacuum_double_t self) -> pvacuum_double_t"},
-	 { "vector_pvacuum_double_t_back", _wrap_vector_pvacuum_double_t_back, METH_O, "vector_pvacuum_double_t_back(vector_pvacuum_double_t self) -> pvacuum_double_t"},
-	 { "vector_pvacuum_double_t_assign", _wrap_vector_pvacuum_double_t_assign, METH_VARARGS, "vector_pvacuum_double_t_assign(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::size_type n, pvacuum_double_t x)"},
-	 { "vector_pvacuum_double_t_resize", _wrap_vector_pvacuum_double_t_resize, METH_VARARGS, "\n"
-		"vector_pvacuum_double_t_resize(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::size_type new_size)\n"
-		"vector_pvacuum_double_t_resize(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::size_type new_size, pvacuum_double_t x)\n"
+	 { "vector_pvacuum_double_T_push_back", _wrap_vector_pvacuum_double_T_push_back, METH_VARARGS, "vector_pvacuum_double_T_push_back(vector_pvacuum_double_T self, pvacuum_double_T x)"},
+	 { "vector_pvacuum_double_T_front", _wrap_vector_pvacuum_double_T_front, METH_O, "vector_pvacuum_double_T_front(vector_pvacuum_double_T self) -> pvacuum_double_T"},
+	 { "vector_pvacuum_double_T_back", _wrap_vector_pvacuum_double_T_back, METH_O, "vector_pvacuum_double_T_back(vector_pvacuum_double_T self) -> pvacuum_double_T"},
+	 { "vector_pvacuum_double_T_assign", _wrap_vector_pvacuum_double_T_assign, METH_VARARGS, "vector_pvacuum_double_T_assign(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::size_type n, pvacuum_double_T x)"},
+	 { "vector_pvacuum_double_T_resize", _wrap_vector_pvacuum_double_T_resize, METH_VARARGS, "\n"
+		"vector_pvacuum_double_T_resize(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::size_type new_size)\n"
+		"vector_pvacuum_double_T_resize(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::size_type new_size, pvacuum_double_T x)\n"
 		""},
-	 { "vector_pvacuum_double_t_insert", _wrap_vector_pvacuum_double_t_insert, METH_VARARGS, "\n"
-		"vector_pvacuum_double_t_insert(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::iterator pos, pvacuum_double_t x) -> std::vector< std::pair< double,double > >::iterator\n"
-		"vector_pvacuum_double_t_insert(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::iterator pos, std::vector< std::pair< double,double > >::size_type n, pvacuum_double_t x)\n"
+	 { "vector_pvacuum_double_T_insert", _wrap_vector_pvacuum_double_T_insert, METH_VARARGS, "\n"
+		"vector_pvacuum_double_T_insert(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::iterator pos, pvacuum_double_T x) -> std::vector< std::pair< double,double > >::iterator\n"
+		"vector_pvacuum_double_T_insert(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::iterator pos, std::vector< std::pair< double,double > >::size_type n, pvacuum_double_T x)\n"
 		""},
-	 { "vector_pvacuum_double_t_reserve", _wrap_vector_pvacuum_double_t_reserve, METH_VARARGS, "vector_pvacuum_double_t_reserve(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::size_type n)"},
-	 { "vector_pvacuum_double_t_capacity", _wrap_vector_pvacuum_double_t_capacity, METH_O, "vector_pvacuum_double_t_capacity(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::size_type"},
-	 { "delete_vector_pvacuum_double_t", _wrap_delete_vector_pvacuum_double_t, METH_O, "delete_vector_pvacuum_double_t(vector_pvacuum_double_t self)"},
-	 { "vector_pvacuum_double_t_swigregister", vector_pvacuum_double_t_swigregister, METH_O, NULL},
-	 { "vector_pvacuum_double_t_swiginit", vector_pvacuum_double_t_swiginit, METH_VARARGS, NULL},
+	 { "vector_pvacuum_double_T_reserve", _wrap_vector_pvacuum_double_T_reserve, METH_VARARGS, "vector_pvacuum_double_T_reserve(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::size_type n)"},
+	 { "vector_pvacuum_double_T_capacity", _wrap_vector_pvacuum_double_T_capacity, METH_O, "vector_pvacuum_double_T_capacity(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::size_type"},
+	 { "delete_vector_pvacuum_double_T", _wrap_delete_vector_pvacuum_double_T, METH_O, "delete_vector_pvacuum_double_T(vector_pvacuum_double_T self)"},
+	 { "vector_pvacuum_double_T_swigregister", vector_pvacuum_double_T_swigregister, METH_O, NULL},
+	 { "vector_pvacuum_double_T_swiginit", vector_pvacuum_double_T_swiginit, METH_VARARGS, NULL},
 	 { "new_R3", _wrap_new_R3, METH_VARARGS, "\n"
 		"R3(double const x_, double const y_, double const z_)\n"
 		"new_R3() -> R3\n"
@@ -43801,13 +43797,13 @@ static PyMethodDef SwigMethods[] = {
 	 { "Coordinate_swigregister", Coordinate_swigregister, METH_O, NULL},
 	 { "Coordinate_swiginit", Coordinate_swiginit, METH_VARARGS, NULL},
 	 { "new_Datafield", _wrap_new_Datafield, METH_VARARGS, "\n"
-		"Datafield(std::string const & title, Frame frame, vdouble1d_t values, vdouble1d_t errSigmas={})\n"
+		"Datafield(std::string const & title, Frame frame, vdouble1d_T values, vdouble1d_T errSigmas={})\n"
 		"Datafield(std::string const & title, Frame frame)\n"
-		"Datafield(Frame frame, vdouble1d_t values, vdouble1d_t errSigmas={})\n"
+		"Datafield(Frame frame, vdouble1d_T values, vdouble1d_T errSigmas={})\n"
 		"Datafield(Frame frame)\n"
-		"Datafield(std::vector< Scale const *,std::allocator< Scale const * > > const & axes, vdouble1d_t values, vdouble1d_t errSigmas={})\n"
+		"Datafield(std::vector< Scale const *,std::allocator< Scale const * > > const & axes, vdouble1d_T values, vdouble1d_T errSigmas={})\n"
 		"Datafield(std::vector< Scale const *,std::allocator< Scale const * > > const & axes)\n"
-		"Datafield(std::string const & xlabel, std::string const & ylabel, vdouble2d_t vec)\n"
+		"Datafield(std::string const & xlabel, std::string const & ylabel, double2d_t const & vec)\n"
 		"new_Datafield(Datafield arg1) -> Datafield\n"
 		""},
 	 { "delete_Datafield", _wrap_delete_Datafield, METH_O, "delete_Datafield(Datafield self)"},
@@ -43826,7 +43822,7 @@ static PyMethodDef SwigMethods[] = {
 	 { "Datafield_yAxis", _wrap_Datafield_yAxis, METH_O, "Datafield_yAxis(Datafield self) -> Scale"},
 	 { "Datafield_size", _wrap_Datafield_size, METH_O, "Datafield_size(Datafield self) -> size_t"},
 	 { "Datafield_empty", _wrap_Datafield_empty, METH_O, "Datafield_empty(Datafield self) -> bool"},
-	 { "Datafield_flatVector", _wrap_Datafield_flatVector, METH_O, "Datafield_flatVector(Datafield self) -> vdouble1d_t"},
+	 { "Datafield_flatVector", _wrap_Datafield_flatVector, METH_O, "Datafield_flatVector(Datafield self) -> vdouble1d_T"},
 	 { "Datafield_maxVal", _wrap_Datafield_maxVal, METH_O, "Datafield_maxVal(Datafield self) -> double"},
 	 { "Datafield_minVal", _wrap_Datafield_minVal, METH_O, "Datafield_minVal(Datafield self) -> double"},
 	 { "Datafield_plottableField", _wrap_Datafield_plottableField, METH_O, "Datafield_plottableField(Datafield self) -> Datafield"},
@@ -43851,7 +43847,7 @@ static PyMethodDef SwigMethods[] = {
 		"Datafield_yProjection(Datafield self, double xlow, double xup) -> Datafield\n"
 		""},
 	 { "Datafield_setAllTo", _wrap_Datafield_setAllTo, METH_VARARGS, "Datafield_setAllTo(Datafield self, double const & value)"},
-	 { "Datafield_errorSigmas", _wrap_Datafield_errorSigmas, METH_O, "Datafield_errorSigmas(Datafield self) -> vdouble1d_t"},
+	 { "Datafield_errorSigmas", _wrap_Datafield_errorSigmas, METH_O, "Datafield_errorSigmas(Datafield self) -> vdouble1d_T"},
 	 { "Datafield_swigregister", Datafield_swigregister, METH_O, NULL},
 	 { "Datafield_swiginit", Datafield_swiginit, METH_VARARGS, NULL},
 	 { "new_Beam", _wrap_new_Beam, METH_VARARGS, "Beam(double intensity, double wavelength, double alpha, double phi=0)"},
@@ -43870,7 +43866,7 @@ static PyMethodDef SwigMethods[] = {
 	 { "IFootprint_validate", _wrap_IFootprint_validate, METH_O, "IFootprint_validate(IFootprint self) -> std::string"},
 	 { "IFootprint_swigregister", IFootprint_swigregister, METH_O, NULL},
 	 { "new_FootprintGauss", _wrap_new_FootprintGauss, METH_VARARGS, "\n"
-		"FootprintGauss(vdouble1d_t P)\n"
+		"FootprintGauss(vdouble1d_T P)\n"
 		"new_FootprintGauss(double width_ratio) -> FootprintGauss\n"
 		""},
 	 { "FootprintGauss_clone", _wrap_FootprintGauss_clone, METH_O, "FootprintGauss_clone(FootprintGauss self) -> FootprintGauss"},
@@ -43880,7 +43876,7 @@ static PyMethodDef SwigMethods[] = {
 	 { "FootprintGauss_swigregister", FootprintGauss_swigregister, METH_O, NULL},
 	 { "FootprintGauss_swiginit", FootprintGauss_swiginit, METH_VARARGS, NULL},
 	 { "new_FootprintSquare", _wrap_new_FootprintSquare, METH_VARARGS, "\n"
-		"FootprintSquare(vdouble1d_t P)\n"
+		"FootprintSquare(vdouble1d_T P)\n"
 		"new_FootprintSquare(double width_ratio) -> FootprintSquare\n"
 		""},
 	 { "FootprintSquare_clone", _wrap_FootprintSquare_clone, METH_O, "FootprintSquare_clone(FootprintSquare self) -> FootprintSquare"},
@@ -43940,7 +43936,7 @@ static PyMethodDef SwigMethods[] = {
 	 { "HorizontalLine_swigregister", HorizontalLine_swigregister, METH_O, NULL},
 	 { "HorizontalLine_swiginit", HorizontalLine_swiginit, METH_VARARGS, NULL},
 	 { "new_Polygon", _wrap_new_Polygon, METH_VARARGS, "\n"
-		"Polygon(vector_pvacuum_double_t points)\n"
+		"Polygon(vector_pvacuum_double_T points)\n"
 		"new_Polygon(PolygonPrivate const * d) -> Polygon\n"
 		""},
 	 { "delete_Polygon", _wrap_delete_Polygon, METH_O, "delete_Polygon(Polygon self)"},
@@ -43950,7 +43946,7 @@ static PyMethodDef SwigMethods[] = {
 		"Polygon_contains(Polygon self, Bin1D const & binx, Bin1D const & biny) -> bool\n"
 		""},
 	 { "Polygon_getArea", _wrap_Polygon_getArea, METH_O, "Polygon_getArea(Polygon self) -> double"},
-	 { "Polygon_getPoints", _wrap_Polygon_getPoints, METH_VARARGS, "Polygon_getPoints(Polygon self, vdouble1d_t xpos, vdouble1d_t ypos)"},
+	 { "Polygon_getPoints", _wrap_Polygon_getPoints, METH_VARARGS, "Polygon_getPoints(Polygon self, vdouble1d_T xpos, vdouble1d_T ypos)"},
 	 { "Polygon_swigregister", Polygon_swigregister, METH_O, NULL},
 	 { "Polygon_swiginit", Polygon_swiginit, METH_VARARGS, NULL},
 	 { "new_Rectangle", _wrap_new_Rectangle, METH_VARARGS, "Rectangle(double xlow, double ylow, double xup, double yup, bool inverted=False)"},
@@ -44027,7 +44023,7 @@ static PyMethodDef SwigMethods[] = {
 	 { "OffspecDetector_analyzer", _wrap_OffspecDetector_analyzer, METH_O, "OffspecDetector_analyzer(OffspecDetector self) -> PolFilter const &"},
 	 { "OffspecDetector_swigregister", OffspecDetector_swigregister, METH_O, NULL},
 	 { "OffspecDetector_swiginit", OffspecDetector_swiginit, METH_VARARGS, NULL},
-	 { "checkRelVecDifference", _wrap_checkRelVecDifference, METH_VARARGS, "checkRelVecDifference(vdouble1d_t dat, vdouble1d_t ref, double threshold) -> bool"},
+	 { "checkRelVecDifference", _wrap_checkRelVecDifference, METH_VARARGS, "checkRelVecDifference(vdouble1d_T dat, vdouble1d_T ref, double threshold) -> bool"},
 	 { "checkRelativeDifference", _wrap_checkRelativeDifference, METH_VARARGS, "checkRelativeDifference(Datafield dat, Datafield ref, double threshold) -> bool"},
 	 { "checkConsistence", _wrap_checkConsistence, METH_VARARGS, "checkConsistence(Datafield dat, Datafield ref, double precision, double snr, int allowed_outliers=0) -> bool"},
 	 { "new_ImportSettings1D", _wrap_new_ImportSettings1D, METH_VARARGS, "\n"
@@ -44088,7 +44084,7 @@ static PyMethodDef SwigMethods[] = {
 		""},
 	 { "writeDatafield", _wrap_writeDatafield, METH_VARARGS, "writeDatafield(Datafield data, std::string const & fname)"},
 	 { "dataMatchesFile", _wrap_dataMatchesFile, METH_VARARGS, "dataMatchesFile(Datafield data, std::string const & refFileName, double tol) -> bool"},
-	 { "FindPeaks", _wrap_FindPeaks, METH_VARARGS, "FindPeaks(Datafield data, double sigma=2, std::string const & option={}, double threshold=0.05) -> vector_pvacuum_double_t"},
+	 { "FindPeaks", _wrap_FindPeaks, METH_VARARGS, "FindPeaks(Datafield data, double sigma=2, std::string const & option={}, double threshold=0.05) -> vector_pvacuum_double_T"},
 	 { NULL, NULL, 0, NULL }
 };
 
@@ -44240,8 +44236,8 @@ static swig_type_info _swigt__p_VerticalLine = {"_p_VerticalLine", "VerticalLine
 static swig_type_info _swigt__p_allocator_type = {"_p_allocator_type", "allocator_type *", 0, 0, (void*)0, 0};
 static swig_type_info _swigt__p_char = {"_p_char", "char *", 0, 0, (void*)0, 0};
 static swig_type_info _swigt__p_const_iterator = {"_p_const_iterator", "const_iterator *", 0, 0, (void*)0, 0};
-static swig_type_info _swigt__p_corr_matrix_t = {"_p_corr_matrix_t", "corr_matrix_t *", 0, 0, (void*)0, 0};
 static swig_type_info _swigt__p_difference_type = {"_p_difference_type", "difference_type *", 0, 0, (void*)0, 0};
+static swig_type_info _swigt__p_double2d_t = {"_p_double2d_t", "double2d_t *", 0, 0, (void*)0, 0};
 static swig_type_info _swigt__p_first_type = {"_p_first_type", "first_type *", 0, 0, (void*)0, 0};
 static swig_type_info _swigt__p_int = {"_p_int", "int32_t *|int_fast16_t *|int_fast32_t *|int_least32_t *|intptr_t *|int *", 0, 0, (void*)0, 0};
 static swig_type_info _swigt__p_iterator = {"_p_iterator", "iterator *", 0, 0, (void*)0, 0};
@@ -44327,8 +44323,8 @@ static swig_type_info *swig_type_initial[] = {
   &_swigt__p_allocator_type,
   &_swigt__p_char,
   &_swigt__p_const_iterator,
-  &_swigt__p_corr_matrix_t,
   &_swigt__p_difference_type,
+  &_swigt__p_double2d_t,
   &_swigt__p_first_type,
   &_swigt__p_int,
   &_swigt__p_iterator,
@@ -44414,8 +44410,8 @@ static swig_cast_info _swigc__p_VerticalLine[] = {  {&_swigt__p_VerticalLine, 0,
 static swig_cast_info _swigc__p_allocator_type[] = {  {&_swigt__p_allocator_type, 0, 0, 0},{0, 0, 0, 0}};
 static swig_cast_info _swigc__p_char[] = {  {&_swigt__p_char, 0, 0, 0},{0, 0, 0, 0}};
 static swig_cast_info _swigc__p_const_iterator[] = {  {&_swigt__p_const_iterator, 0, 0, 0},{0, 0, 0, 0}};
-static swig_cast_info _swigc__p_corr_matrix_t[] = {  {&_swigt__p_corr_matrix_t, 0, 0, 0},{0, 0, 0, 0}};
 static swig_cast_info _swigc__p_difference_type[] = {  {&_swigt__p_difference_type, 0, 0, 0},{0, 0, 0, 0}};
+static swig_cast_info _swigc__p_double2d_t[] = {  {&_swigt__p_double2d_t, 0, 0, 0},{0, 0, 0, 0}};
 static swig_cast_info _swigc__p_first_type[] = {  {&_swigt__p_first_type, 0, 0, 0},{0, 0, 0, 0}};
 static swig_cast_info _swigc__p_int[] = {  {&_swigt__p_int, 0, 0, 0},{0, 0, 0, 0}};
 static swig_cast_info _swigc__p_iterator[] = {  {&_swigt__p_iterator, 0, 0, 0},{0, 0, 0, 0}};
@@ -44501,8 +44497,8 @@ static swig_cast_info *swig_cast_initial[] = {
   _swigc__p_allocator_type,
   _swigc__p_char,
   _swigc__p_const_iterator,
-  _swigc__p_corr_matrix_t,
   _swigc__p_difference_type,
+  _swigc__p_double2d_t,
   _swigc__p_first_type,
   _swigc__p_int,
   _swigc__p_iterator,
diff --git a/auto/Wrap/libBornAgainFit.py b/auto/Wrap/libBornAgainFit.py
index a7d33684b2f5f2b0e605417c0731aa0b02908d7e..d1103f5cb83b1ea77fa40111943c298bc4975a8b 100644
--- a/auto/Wrap/libBornAgainFit.py
+++ b/auto/Wrap/libBornAgainFit.py
@@ -153,1191 +153,1191 @@ def deprecated(message):
       return deprecated_func
   return deprecated_decorator
 
-class vdouble1d_t(object):
+class vdouble1d_T(object):
     r"""Proxy of C++ std::vector< double > class."""
 
     thisown = property(lambda x: x.this.own(), lambda x, v: x.this.own(v), doc="The membership flag")
     __repr__ = _swig_repr
 
     def iterator(self):
-        r"""iterator(vdouble1d_t self) -> SwigPyIterator"""
-        return _libBornAgainFit.vdouble1d_t_iterator(self)
+        r"""iterator(vdouble1d_T self) -> SwigPyIterator"""
+        return _libBornAgainFit.vdouble1d_T_iterator(self)
     def __iter__(self):
         return self.iterator()
 
     def __nonzero__(self):
-        r"""__nonzero__(vdouble1d_t self) -> bool"""
-        return _libBornAgainFit.vdouble1d_t___nonzero__(self)
+        r"""__nonzero__(vdouble1d_T self) -> bool"""
+        return _libBornAgainFit.vdouble1d_T___nonzero__(self)
 
     def __bool__(self):
-        r"""__bool__(vdouble1d_t self) -> bool"""
-        return _libBornAgainFit.vdouble1d_t___bool__(self)
+        r"""__bool__(vdouble1d_T self) -> bool"""
+        return _libBornAgainFit.vdouble1d_T___bool__(self)
 
     def __len__(self):
-        r"""__len__(vdouble1d_t self) -> std::vector< double >::size_type"""
-        return _libBornAgainFit.vdouble1d_t___len__(self)
+        r"""__len__(vdouble1d_T self) -> std::vector< double >::size_type"""
+        return _libBornAgainFit.vdouble1d_T___len__(self)
 
     def __getslice__(self, i, j):
-        r"""__getslice__(vdouble1d_t self, std::vector< double >::difference_type i, std::vector< double >::difference_type j) -> vdouble1d_t"""
-        return _libBornAgainFit.vdouble1d_t___getslice__(self, i, j)
+        r"""__getslice__(vdouble1d_T self, std::vector< double >::difference_type i, std::vector< double >::difference_type j) -> vdouble1d_T"""
+        return _libBornAgainFit.vdouble1d_T___getslice__(self, i, j)
 
     def __setslice__(self, *args):
         r"""
-        __setslice__(vdouble1d_t self, std::vector< double >::difference_type i, std::vector< double >::difference_type j)
-        __setslice__(vdouble1d_t self, std::vector< double >::difference_type i, std::vector< double >::difference_type j, vdouble1d_t v)
+        __setslice__(vdouble1d_T self, std::vector< double >::difference_type i, std::vector< double >::difference_type j)
+        __setslice__(vdouble1d_T self, std::vector< double >::difference_type i, std::vector< double >::difference_type j, vdouble1d_T v)
         """
-        return _libBornAgainFit.vdouble1d_t___setslice__(self, *args)
+        return _libBornAgainFit.vdouble1d_T___setslice__(self, *args)
 
     def __delslice__(self, i, j):
-        r"""__delslice__(vdouble1d_t self, std::vector< double >::difference_type i, std::vector< double >::difference_type j)"""
-        return _libBornAgainFit.vdouble1d_t___delslice__(self, i, j)
+        r"""__delslice__(vdouble1d_T self, std::vector< double >::difference_type i, std::vector< double >::difference_type j)"""
+        return _libBornAgainFit.vdouble1d_T___delslice__(self, i, j)
 
     def __delitem__(self, *args):
         r"""
-        __delitem__(vdouble1d_t self, std::vector< double >::difference_type i)
-        __delitem__(vdouble1d_t self, SWIGPY_SLICEOBJECT * slice)
+        __delitem__(vdouble1d_T self, std::vector< double >::difference_type i)
+        __delitem__(vdouble1d_T self, SWIGPY_SLICEOBJECT * slice)
         """
-        return _libBornAgainFit.vdouble1d_t___delitem__(self, *args)
+        return _libBornAgainFit.vdouble1d_T___delitem__(self, *args)
 
     def __getitem__(self, *args):
         r"""
-        __getitem__(vdouble1d_t self, SWIGPY_SLICEOBJECT * slice) -> vdouble1d_t
-        __getitem__(vdouble1d_t self, std::vector< double >::difference_type i) -> std::vector< double >::value_type const &
+        __getitem__(vdouble1d_T self, SWIGPY_SLICEOBJECT * slice) -> vdouble1d_T
+        __getitem__(vdouble1d_T self, std::vector< double >::difference_type i) -> std::vector< double >::value_type const &
         """
-        return _libBornAgainFit.vdouble1d_t___getitem__(self, *args)
+        return _libBornAgainFit.vdouble1d_T___getitem__(self, *args)
 
     def __setitem__(self, *args):
         r"""
-        __setitem__(vdouble1d_t self, SWIGPY_SLICEOBJECT * slice, vdouble1d_t v)
-        __setitem__(vdouble1d_t self, SWIGPY_SLICEOBJECT * slice)
-        __setitem__(vdouble1d_t self, std::vector< double >::difference_type i, std::vector< double >::value_type const & x)
+        __setitem__(vdouble1d_T self, SWIGPY_SLICEOBJECT * slice, vdouble1d_T v)
+        __setitem__(vdouble1d_T self, SWIGPY_SLICEOBJECT * slice)
+        __setitem__(vdouble1d_T self, std::vector< double >::difference_type i, std::vector< double >::value_type const & x)
         """
-        return _libBornAgainFit.vdouble1d_t___setitem__(self, *args)
+        return _libBornAgainFit.vdouble1d_T___setitem__(self, *args)
 
     def pop(self):
-        r"""pop(vdouble1d_t self) -> std::vector< double >::value_type"""
-        return _libBornAgainFit.vdouble1d_t_pop(self)
+        r"""pop(vdouble1d_T self) -> std::vector< double >::value_type"""
+        return _libBornAgainFit.vdouble1d_T_pop(self)
 
     def append(self, x):
-        r"""append(vdouble1d_t self, std::vector< double >::value_type const & x)"""
-        return _libBornAgainFit.vdouble1d_t_append(self, x)
+        r"""append(vdouble1d_T self, std::vector< double >::value_type const & x)"""
+        return _libBornAgainFit.vdouble1d_T_append(self, x)
 
     def empty(self):
-        r"""empty(vdouble1d_t self) -> bool"""
-        return _libBornAgainFit.vdouble1d_t_empty(self)
+        r"""empty(vdouble1d_T self) -> bool"""
+        return _libBornAgainFit.vdouble1d_T_empty(self)
 
     def size(self):
-        r"""size(vdouble1d_t self) -> std::vector< double >::size_type"""
-        return _libBornAgainFit.vdouble1d_t_size(self)
+        r"""size(vdouble1d_T self) -> std::vector< double >::size_type"""
+        return _libBornAgainFit.vdouble1d_T_size(self)
 
     def swap(self, v):
-        r"""swap(vdouble1d_t self, vdouble1d_t v)"""
-        return _libBornAgainFit.vdouble1d_t_swap(self, v)
+        r"""swap(vdouble1d_T self, vdouble1d_T v)"""
+        return _libBornAgainFit.vdouble1d_T_swap(self, v)
 
     def begin(self):
-        r"""begin(vdouble1d_t self) -> std::vector< double >::iterator"""
-        return _libBornAgainFit.vdouble1d_t_begin(self)
+        r"""begin(vdouble1d_T self) -> std::vector< double >::iterator"""
+        return _libBornAgainFit.vdouble1d_T_begin(self)
 
     def end(self):
-        r"""end(vdouble1d_t self) -> std::vector< double >::iterator"""
-        return _libBornAgainFit.vdouble1d_t_end(self)
+        r"""end(vdouble1d_T self) -> std::vector< double >::iterator"""
+        return _libBornAgainFit.vdouble1d_T_end(self)
 
     def rbegin(self):
-        r"""rbegin(vdouble1d_t self) -> std::vector< double >::reverse_iterator"""
-        return _libBornAgainFit.vdouble1d_t_rbegin(self)
+        r"""rbegin(vdouble1d_T self) -> std::vector< double >::reverse_iterator"""
+        return _libBornAgainFit.vdouble1d_T_rbegin(self)
 
     def rend(self):
-        r"""rend(vdouble1d_t self) -> std::vector< double >::reverse_iterator"""
-        return _libBornAgainFit.vdouble1d_t_rend(self)
+        r"""rend(vdouble1d_T self) -> std::vector< double >::reverse_iterator"""
+        return _libBornAgainFit.vdouble1d_T_rend(self)
 
     def clear(self):
-        r"""clear(vdouble1d_t self)"""
-        return _libBornAgainFit.vdouble1d_t_clear(self)
+        r"""clear(vdouble1d_T self)"""
+        return _libBornAgainFit.vdouble1d_T_clear(self)
 
     def get_allocator(self):
-        r"""get_allocator(vdouble1d_t self) -> std::vector< double >::allocator_type"""
-        return _libBornAgainFit.vdouble1d_t_get_allocator(self)
+        r"""get_allocator(vdouble1d_T self) -> std::vector< double >::allocator_type"""
+        return _libBornAgainFit.vdouble1d_T_get_allocator(self)
 
     def pop_back(self):
-        r"""pop_back(vdouble1d_t self)"""
-        return _libBornAgainFit.vdouble1d_t_pop_back(self)
+        r"""pop_back(vdouble1d_T self)"""
+        return _libBornAgainFit.vdouble1d_T_pop_back(self)
 
     def erase(self, *args):
         r"""
-        erase(vdouble1d_t self, std::vector< double >::iterator pos) -> std::vector< double >::iterator
-        erase(vdouble1d_t self, std::vector< double >::iterator first, std::vector< double >::iterator last) -> std::vector< double >::iterator
+        erase(vdouble1d_T self, std::vector< double >::iterator pos) -> std::vector< double >::iterator
+        erase(vdouble1d_T self, std::vector< double >::iterator first, std::vector< double >::iterator last) -> std::vector< double >::iterator
         """
-        return _libBornAgainFit.vdouble1d_t_erase(self, *args)
+        return _libBornAgainFit.vdouble1d_T_erase(self, *args)
 
     def __init__(self, *args):
         r"""
-        __init__(vdouble1d_t self) -> vdouble1d_t
-        __init__(vdouble1d_t self, vdouble1d_t other) -> vdouble1d_t
-        __init__(vdouble1d_t self, std::vector< double >::size_type size) -> vdouble1d_t
-        __init__(vdouble1d_t self, std::vector< double >::size_type size, std::vector< double >::value_type const & value) -> vdouble1d_t
+        __init__(vdouble1d_T self) -> vdouble1d_T
+        __init__(vdouble1d_T self, vdouble1d_T other) -> vdouble1d_T
+        __init__(vdouble1d_T self, std::vector< double >::size_type size) -> vdouble1d_T
+        __init__(vdouble1d_T self, std::vector< double >::size_type size, std::vector< double >::value_type const & value) -> vdouble1d_T
         """
-        _libBornAgainFit.vdouble1d_t_swiginit(self, _libBornAgainFit.new_vdouble1d_t(*args))
+        _libBornAgainFit.vdouble1d_T_swiginit(self, _libBornAgainFit.new_vdouble1d_T(*args))
 
     def push_back(self, x):
-        r"""push_back(vdouble1d_t self, std::vector< double >::value_type const & x)"""
-        return _libBornAgainFit.vdouble1d_t_push_back(self, x)
+        r"""push_back(vdouble1d_T self, std::vector< double >::value_type const & x)"""
+        return _libBornAgainFit.vdouble1d_T_push_back(self, x)
 
     def front(self):
-        r"""front(vdouble1d_t self) -> std::vector< double >::value_type const &"""
-        return _libBornAgainFit.vdouble1d_t_front(self)
+        r"""front(vdouble1d_T self) -> std::vector< double >::value_type const &"""
+        return _libBornAgainFit.vdouble1d_T_front(self)
 
     def back(self):
-        r"""back(vdouble1d_t self) -> std::vector< double >::value_type const &"""
-        return _libBornAgainFit.vdouble1d_t_back(self)
+        r"""back(vdouble1d_T self) -> std::vector< double >::value_type const &"""
+        return _libBornAgainFit.vdouble1d_T_back(self)
 
     def assign(self, n, x):
-        r"""assign(vdouble1d_t self, std::vector< double >::size_type n, std::vector< double >::value_type const & x)"""
-        return _libBornAgainFit.vdouble1d_t_assign(self, n, x)
+        r"""assign(vdouble1d_T self, std::vector< double >::size_type n, std::vector< double >::value_type const & x)"""
+        return _libBornAgainFit.vdouble1d_T_assign(self, n, x)
 
     def resize(self, *args):
         r"""
-        resize(vdouble1d_t self, std::vector< double >::size_type new_size)
-        resize(vdouble1d_t self, std::vector< double >::size_type new_size, std::vector< double >::value_type const & x)
+        resize(vdouble1d_T self, std::vector< double >::size_type new_size)
+        resize(vdouble1d_T self, std::vector< double >::size_type new_size, std::vector< double >::value_type const & x)
         """
-        return _libBornAgainFit.vdouble1d_t_resize(self, *args)
+        return _libBornAgainFit.vdouble1d_T_resize(self, *args)
 
     def insert(self, *args):
         r"""
-        insert(vdouble1d_t self, std::vector< double >::iterator pos, std::vector< double >::value_type const & x) -> std::vector< double >::iterator
-        insert(vdouble1d_t self, std::vector< double >::iterator pos, std::vector< double >::size_type n, std::vector< double >::value_type const & x)
+        insert(vdouble1d_T self, std::vector< double >::iterator pos, std::vector< double >::value_type const & x) -> std::vector< double >::iterator
+        insert(vdouble1d_T self, std::vector< double >::iterator pos, std::vector< double >::size_type n, std::vector< double >::value_type const & x)
         """
-        return _libBornAgainFit.vdouble1d_t_insert(self, *args)
+        return _libBornAgainFit.vdouble1d_T_insert(self, *args)
 
     def reserve(self, n):
-        r"""reserve(vdouble1d_t self, std::vector< double >::size_type n)"""
-        return _libBornAgainFit.vdouble1d_t_reserve(self, n)
+        r"""reserve(vdouble1d_T self, std::vector< double >::size_type n)"""
+        return _libBornAgainFit.vdouble1d_T_reserve(self, n)
 
     def capacity(self):
-        r"""capacity(vdouble1d_t self) -> std::vector< double >::size_type"""
-        return _libBornAgainFit.vdouble1d_t_capacity(self)
-    __swig_destroy__ = _libBornAgainFit.delete_vdouble1d_t
+        r"""capacity(vdouble1d_T self) -> std::vector< double >::size_type"""
+        return _libBornAgainFit.vdouble1d_T_capacity(self)
+    __swig_destroy__ = _libBornAgainFit.delete_vdouble1d_T
 
-# Register vdouble1d_t in _libBornAgainFit:
-_libBornAgainFit.vdouble1d_t_swigregister(vdouble1d_t)
-class vdouble2d_t(object):
+# Register vdouble1d_T in _libBornAgainFit:
+_libBornAgainFit.vdouble1d_T_swigregister(vdouble1d_T)
+class vdouble2d_T(object):
     r"""Proxy of C++ std::vector< std::vector< double > > class."""
 
     thisown = property(lambda x: x.this.own(), lambda x, v: x.this.own(v), doc="The membership flag")
     __repr__ = _swig_repr
 
     def iterator(self):
-        r"""iterator(vdouble2d_t self) -> SwigPyIterator"""
-        return _libBornAgainFit.vdouble2d_t_iterator(self)
+        r"""iterator(vdouble2d_T self) -> SwigPyIterator"""
+        return _libBornAgainFit.vdouble2d_T_iterator(self)
     def __iter__(self):
         return self.iterator()
 
     def __nonzero__(self):
-        r"""__nonzero__(vdouble2d_t self) -> bool"""
-        return _libBornAgainFit.vdouble2d_t___nonzero__(self)
+        r"""__nonzero__(vdouble2d_T self) -> bool"""
+        return _libBornAgainFit.vdouble2d_T___nonzero__(self)
 
     def __bool__(self):
-        r"""__bool__(vdouble2d_t self) -> bool"""
-        return _libBornAgainFit.vdouble2d_t___bool__(self)
+        r"""__bool__(vdouble2d_T self) -> bool"""
+        return _libBornAgainFit.vdouble2d_T___bool__(self)
 
     def __len__(self):
-        r"""__len__(vdouble2d_t self) -> std::vector< std::vector< double > >::size_type"""
-        return _libBornAgainFit.vdouble2d_t___len__(self)
+        r"""__len__(vdouble2d_T self) -> std::vector< std::vector< double > >::size_type"""
+        return _libBornAgainFit.vdouble2d_T___len__(self)
 
     def __getslice__(self, i, j):
-        r"""__getslice__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j) -> vdouble2d_t"""
-        return _libBornAgainFit.vdouble2d_t___getslice__(self, i, j)
+        r"""__getslice__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j) -> vdouble2d_T"""
+        return _libBornAgainFit.vdouble2d_T___getslice__(self, i, j)
 
     def __setslice__(self, *args):
         r"""
-        __setslice__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j)
-        __setslice__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j, vdouble2d_t v)
+        __setslice__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j)
+        __setslice__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j, vdouble2d_T v)
         """
-        return _libBornAgainFit.vdouble2d_t___setslice__(self, *args)
+        return _libBornAgainFit.vdouble2d_T___setslice__(self, *args)
 
     def __delslice__(self, i, j):
-        r"""__delslice__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j)"""
-        return _libBornAgainFit.vdouble2d_t___delslice__(self, i, j)
+        r"""__delslice__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j)"""
+        return _libBornAgainFit.vdouble2d_T___delslice__(self, i, j)
 
     def __delitem__(self, *args):
         r"""
-        __delitem__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i)
-        __delitem__(vdouble2d_t self, SWIGPY_SLICEOBJECT * slice)
+        __delitem__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i)
+        __delitem__(vdouble2d_T self, SWIGPY_SLICEOBJECT * slice)
         """
-        return _libBornAgainFit.vdouble2d_t___delitem__(self, *args)
+        return _libBornAgainFit.vdouble2d_T___delitem__(self, *args)
 
     def __getitem__(self, *args):
         r"""
-        __getitem__(vdouble2d_t self, SWIGPY_SLICEOBJECT * slice) -> vdouble2d_t
-        __getitem__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i) -> vdouble1d_t
+        __getitem__(vdouble2d_T self, SWIGPY_SLICEOBJECT * slice) -> vdouble2d_T
+        __getitem__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i) -> vdouble1d_T
         """
-        return _libBornAgainFit.vdouble2d_t___getitem__(self, *args)
+        return _libBornAgainFit.vdouble2d_T___getitem__(self, *args)
 
     def __setitem__(self, *args):
         r"""
-        __setitem__(vdouble2d_t self, SWIGPY_SLICEOBJECT * slice, vdouble2d_t v)
-        __setitem__(vdouble2d_t self, SWIGPY_SLICEOBJECT * slice)
-        __setitem__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i, vdouble1d_t x)
+        __setitem__(vdouble2d_T self, SWIGPY_SLICEOBJECT * slice, vdouble2d_T v)
+        __setitem__(vdouble2d_T self, SWIGPY_SLICEOBJECT * slice)
+        __setitem__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i, vdouble1d_T x)
         """
-        return _libBornAgainFit.vdouble2d_t___setitem__(self, *args)
+        return _libBornAgainFit.vdouble2d_T___setitem__(self, *args)
 
     def pop(self):
-        r"""pop(vdouble2d_t self) -> vdouble1d_t"""
-        return _libBornAgainFit.vdouble2d_t_pop(self)
+        r"""pop(vdouble2d_T self) -> vdouble1d_T"""
+        return _libBornAgainFit.vdouble2d_T_pop(self)
 
     def append(self, x):
-        r"""append(vdouble2d_t self, vdouble1d_t x)"""
-        return _libBornAgainFit.vdouble2d_t_append(self, x)
+        r"""append(vdouble2d_T self, vdouble1d_T x)"""
+        return _libBornAgainFit.vdouble2d_T_append(self, x)
 
     def empty(self):
-        r"""empty(vdouble2d_t self) -> bool"""
-        return _libBornAgainFit.vdouble2d_t_empty(self)
+        r"""empty(vdouble2d_T self) -> bool"""
+        return _libBornAgainFit.vdouble2d_T_empty(self)
 
     def size(self):
-        r"""size(vdouble2d_t self) -> std::vector< std::vector< double > >::size_type"""
-        return _libBornAgainFit.vdouble2d_t_size(self)
+        r"""size(vdouble2d_T self) -> std::vector< std::vector< double > >::size_type"""
+        return _libBornAgainFit.vdouble2d_T_size(self)
 
     def swap(self, v):
-        r"""swap(vdouble2d_t self, vdouble2d_t v)"""
-        return _libBornAgainFit.vdouble2d_t_swap(self, v)
+        r"""swap(vdouble2d_T self, vdouble2d_T v)"""
+        return _libBornAgainFit.vdouble2d_T_swap(self, v)
 
     def begin(self):
-        r"""begin(vdouble2d_t self) -> std::vector< std::vector< double > >::iterator"""
-        return _libBornAgainFit.vdouble2d_t_begin(self)
+        r"""begin(vdouble2d_T self) -> std::vector< std::vector< double > >::iterator"""
+        return _libBornAgainFit.vdouble2d_T_begin(self)
 
     def end(self):
-        r"""end(vdouble2d_t self) -> std::vector< std::vector< double > >::iterator"""
-        return _libBornAgainFit.vdouble2d_t_end(self)
+        r"""end(vdouble2d_T self) -> std::vector< std::vector< double > >::iterator"""
+        return _libBornAgainFit.vdouble2d_T_end(self)
 
     def rbegin(self):
-        r"""rbegin(vdouble2d_t self) -> std::vector< std::vector< double > >::reverse_iterator"""
-        return _libBornAgainFit.vdouble2d_t_rbegin(self)
+        r"""rbegin(vdouble2d_T self) -> std::vector< std::vector< double > >::reverse_iterator"""
+        return _libBornAgainFit.vdouble2d_T_rbegin(self)
 
     def rend(self):
-        r"""rend(vdouble2d_t self) -> std::vector< std::vector< double > >::reverse_iterator"""
-        return _libBornAgainFit.vdouble2d_t_rend(self)
+        r"""rend(vdouble2d_T self) -> std::vector< std::vector< double > >::reverse_iterator"""
+        return _libBornAgainFit.vdouble2d_T_rend(self)
 
     def clear(self):
-        r"""clear(vdouble2d_t self)"""
-        return _libBornAgainFit.vdouble2d_t_clear(self)
+        r"""clear(vdouble2d_T self)"""
+        return _libBornAgainFit.vdouble2d_T_clear(self)
 
     def get_allocator(self):
-        r"""get_allocator(vdouble2d_t self) -> std::vector< std::vector< double > >::allocator_type"""
-        return _libBornAgainFit.vdouble2d_t_get_allocator(self)
+        r"""get_allocator(vdouble2d_T self) -> std::vector< std::vector< double > >::allocator_type"""
+        return _libBornAgainFit.vdouble2d_T_get_allocator(self)
 
     def pop_back(self):
-        r"""pop_back(vdouble2d_t self)"""
-        return _libBornAgainFit.vdouble2d_t_pop_back(self)
+        r"""pop_back(vdouble2d_T self)"""
+        return _libBornAgainFit.vdouble2d_T_pop_back(self)
 
     def erase(self, *args):
         r"""
-        erase(vdouble2d_t self, std::vector< std::vector< double > >::iterator pos) -> std::vector< std::vector< double > >::iterator
-        erase(vdouble2d_t self, std::vector< std::vector< double > >::iterator first, std::vector< std::vector< double > >::iterator last) -> std::vector< std::vector< double > >::iterator
+        erase(vdouble2d_T self, std::vector< std::vector< double > >::iterator pos) -> std::vector< std::vector< double > >::iterator
+        erase(vdouble2d_T self, std::vector< std::vector< double > >::iterator first, std::vector< std::vector< double > >::iterator last) -> std::vector< std::vector< double > >::iterator
         """
-        return _libBornAgainFit.vdouble2d_t_erase(self, *args)
+        return _libBornAgainFit.vdouble2d_T_erase(self, *args)
 
     def __init__(self, *args):
         r"""
-        __init__(vdouble2d_t self) -> vdouble2d_t
-        __init__(vdouble2d_t self, vdouble2d_t other) -> vdouble2d_t
-        __init__(vdouble2d_t self, std::vector< std::vector< double > >::size_type size) -> vdouble2d_t
-        __init__(vdouble2d_t self, std::vector< std::vector< double > >::size_type size, vdouble1d_t value) -> vdouble2d_t
+        __init__(vdouble2d_T self) -> vdouble2d_T
+        __init__(vdouble2d_T self, vdouble2d_T other) -> vdouble2d_T
+        __init__(vdouble2d_T self, std::vector< std::vector< double > >::size_type size) -> vdouble2d_T
+        __init__(vdouble2d_T self, std::vector< std::vector< double > >::size_type size, vdouble1d_T value) -> vdouble2d_T
         """
-        _libBornAgainFit.vdouble2d_t_swiginit(self, _libBornAgainFit.new_vdouble2d_t(*args))
+        _libBornAgainFit.vdouble2d_T_swiginit(self, _libBornAgainFit.new_vdouble2d_T(*args))
 
     def push_back(self, x):
-        r"""push_back(vdouble2d_t self, vdouble1d_t x)"""
-        return _libBornAgainFit.vdouble2d_t_push_back(self, x)
+        r"""push_back(vdouble2d_T self, vdouble1d_T x)"""
+        return _libBornAgainFit.vdouble2d_T_push_back(self, x)
 
     def front(self):
-        r"""front(vdouble2d_t self) -> vdouble1d_t"""
-        return _libBornAgainFit.vdouble2d_t_front(self)
+        r"""front(vdouble2d_T self) -> vdouble1d_T"""
+        return _libBornAgainFit.vdouble2d_T_front(self)
 
     def back(self):
-        r"""back(vdouble2d_t self) -> vdouble1d_t"""
-        return _libBornAgainFit.vdouble2d_t_back(self)
+        r"""back(vdouble2d_T self) -> vdouble1d_T"""
+        return _libBornAgainFit.vdouble2d_T_back(self)
 
     def assign(self, n, x):
-        r"""assign(vdouble2d_t self, std::vector< std::vector< double > >::size_type n, vdouble1d_t x)"""
-        return _libBornAgainFit.vdouble2d_t_assign(self, n, x)
+        r"""assign(vdouble2d_T self, std::vector< std::vector< double > >::size_type n, vdouble1d_T x)"""
+        return _libBornAgainFit.vdouble2d_T_assign(self, n, x)
 
     def resize(self, *args):
         r"""
-        resize(vdouble2d_t self, std::vector< std::vector< double > >::size_type new_size)
-        resize(vdouble2d_t self, std::vector< std::vector< double > >::size_type new_size, vdouble1d_t x)
+        resize(vdouble2d_T self, std::vector< std::vector< double > >::size_type new_size)
+        resize(vdouble2d_T self, std::vector< std::vector< double > >::size_type new_size, vdouble1d_T x)
         """
-        return _libBornAgainFit.vdouble2d_t_resize(self, *args)
+        return _libBornAgainFit.vdouble2d_T_resize(self, *args)
 
     def insert(self, *args):
         r"""
-        insert(vdouble2d_t self, std::vector< std::vector< double > >::iterator pos, vdouble1d_t x) -> std::vector< std::vector< double > >::iterator
-        insert(vdouble2d_t self, std::vector< std::vector< double > >::iterator pos, std::vector< std::vector< double > >::size_type n, vdouble1d_t x)
+        insert(vdouble2d_T self, std::vector< std::vector< double > >::iterator pos, vdouble1d_T x) -> std::vector< std::vector< double > >::iterator
+        insert(vdouble2d_T self, std::vector< std::vector< double > >::iterator pos, std::vector< std::vector< double > >::size_type n, vdouble1d_T x)
         """
-        return _libBornAgainFit.vdouble2d_t_insert(self, *args)
+        return _libBornAgainFit.vdouble2d_T_insert(self, *args)
 
     def reserve(self, n):
-        r"""reserve(vdouble2d_t self, std::vector< std::vector< double > >::size_type n)"""
-        return _libBornAgainFit.vdouble2d_t_reserve(self, n)
+        r"""reserve(vdouble2d_T self, std::vector< std::vector< double > >::size_type n)"""
+        return _libBornAgainFit.vdouble2d_T_reserve(self, n)
 
     def capacity(self):
-        r"""capacity(vdouble2d_t self) -> std::vector< std::vector< double > >::size_type"""
-        return _libBornAgainFit.vdouble2d_t_capacity(self)
-    __swig_destroy__ = _libBornAgainFit.delete_vdouble2d_t
+        r"""capacity(vdouble2d_T self) -> std::vector< std::vector< double > >::size_type"""
+        return _libBornAgainFit.vdouble2d_T_capacity(self)
+    __swig_destroy__ = _libBornAgainFit.delete_vdouble2d_T
 
-# Register vdouble2d_t in _libBornAgainFit:
-_libBornAgainFit.vdouble2d_t_swigregister(vdouble2d_t)
-class vector_integer_t(object):
+# Register vdouble2d_T in _libBornAgainFit:
+_libBornAgainFit.vdouble2d_T_swigregister(vdouble2d_T)
+class vector_integer_T(object):
     r"""Proxy of C++ std::vector< int > class."""
 
     thisown = property(lambda x: x.this.own(), lambda x, v: x.this.own(v), doc="The membership flag")
     __repr__ = _swig_repr
 
     def iterator(self):
-        r"""iterator(vector_integer_t self) -> SwigPyIterator"""
-        return _libBornAgainFit.vector_integer_t_iterator(self)
+        r"""iterator(vector_integer_T self) -> SwigPyIterator"""
+        return _libBornAgainFit.vector_integer_T_iterator(self)
     def __iter__(self):
         return self.iterator()
 
     def __nonzero__(self):
-        r"""__nonzero__(vector_integer_t self) -> bool"""
-        return _libBornAgainFit.vector_integer_t___nonzero__(self)
+        r"""__nonzero__(vector_integer_T self) -> bool"""
+        return _libBornAgainFit.vector_integer_T___nonzero__(self)
 
     def __bool__(self):
-        r"""__bool__(vector_integer_t self) -> bool"""
-        return _libBornAgainFit.vector_integer_t___bool__(self)
+        r"""__bool__(vector_integer_T self) -> bool"""
+        return _libBornAgainFit.vector_integer_T___bool__(self)
 
     def __len__(self):
-        r"""__len__(vector_integer_t self) -> std::vector< int >::size_type"""
-        return _libBornAgainFit.vector_integer_t___len__(self)
+        r"""__len__(vector_integer_T self) -> std::vector< int >::size_type"""
+        return _libBornAgainFit.vector_integer_T___len__(self)
 
     def __getslice__(self, i, j):
-        r"""__getslice__(vector_integer_t self, std::vector< int >::difference_type i, std::vector< int >::difference_type j) -> vector_integer_t"""
-        return _libBornAgainFit.vector_integer_t___getslice__(self, i, j)
+        r"""__getslice__(vector_integer_T self, std::vector< int >::difference_type i, std::vector< int >::difference_type j) -> vector_integer_T"""
+        return _libBornAgainFit.vector_integer_T___getslice__(self, i, j)
 
     def __setslice__(self, *args):
         r"""
-        __setslice__(vector_integer_t self, std::vector< int >::difference_type i, std::vector< int >::difference_type j)
-        __setslice__(vector_integer_t self, std::vector< int >::difference_type i, std::vector< int >::difference_type j, vector_integer_t v)
+        __setslice__(vector_integer_T self, std::vector< int >::difference_type i, std::vector< int >::difference_type j)
+        __setslice__(vector_integer_T self, std::vector< int >::difference_type i, std::vector< int >::difference_type j, vector_integer_T v)
         """
-        return _libBornAgainFit.vector_integer_t___setslice__(self, *args)
+        return _libBornAgainFit.vector_integer_T___setslice__(self, *args)
 
     def __delslice__(self, i, j):
-        r"""__delslice__(vector_integer_t self, std::vector< int >::difference_type i, std::vector< int >::difference_type j)"""
-        return _libBornAgainFit.vector_integer_t___delslice__(self, i, j)
+        r"""__delslice__(vector_integer_T self, std::vector< int >::difference_type i, std::vector< int >::difference_type j)"""
+        return _libBornAgainFit.vector_integer_T___delslice__(self, i, j)
 
     def __delitem__(self, *args):
         r"""
-        __delitem__(vector_integer_t self, std::vector< int >::difference_type i)
-        __delitem__(vector_integer_t self, SWIGPY_SLICEOBJECT * slice)
+        __delitem__(vector_integer_T self, std::vector< int >::difference_type i)
+        __delitem__(vector_integer_T self, SWIGPY_SLICEOBJECT * slice)
         """
-        return _libBornAgainFit.vector_integer_t___delitem__(self, *args)
+        return _libBornAgainFit.vector_integer_T___delitem__(self, *args)
 
     def __getitem__(self, *args):
         r"""
-        __getitem__(vector_integer_t self, SWIGPY_SLICEOBJECT * slice) -> vector_integer_t
-        __getitem__(vector_integer_t self, std::vector< int >::difference_type i) -> std::vector< int >::value_type const &
+        __getitem__(vector_integer_T self, SWIGPY_SLICEOBJECT * slice) -> vector_integer_T
+        __getitem__(vector_integer_T self, std::vector< int >::difference_type i) -> std::vector< int >::value_type const &
         """
-        return _libBornAgainFit.vector_integer_t___getitem__(self, *args)
+        return _libBornAgainFit.vector_integer_T___getitem__(self, *args)
 
     def __setitem__(self, *args):
         r"""
-        __setitem__(vector_integer_t self, SWIGPY_SLICEOBJECT * slice, vector_integer_t v)
-        __setitem__(vector_integer_t self, SWIGPY_SLICEOBJECT * slice)
-        __setitem__(vector_integer_t self, std::vector< int >::difference_type i, std::vector< int >::value_type const & x)
+        __setitem__(vector_integer_T self, SWIGPY_SLICEOBJECT * slice, vector_integer_T v)
+        __setitem__(vector_integer_T self, SWIGPY_SLICEOBJECT * slice)
+        __setitem__(vector_integer_T self, std::vector< int >::difference_type i, std::vector< int >::value_type const & x)
         """
-        return _libBornAgainFit.vector_integer_t___setitem__(self, *args)
+        return _libBornAgainFit.vector_integer_T___setitem__(self, *args)
 
     def pop(self):
-        r"""pop(vector_integer_t self) -> std::vector< int >::value_type"""
-        return _libBornAgainFit.vector_integer_t_pop(self)
+        r"""pop(vector_integer_T self) -> std::vector< int >::value_type"""
+        return _libBornAgainFit.vector_integer_T_pop(self)
 
     def append(self, x):
-        r"""append(vector_integer_t self, std::vector< int >::value_type const & x)"""
-        return _libBornAgainFit.vector_integer_t_append(self, x)
+        r"""append(vector_integer_T self, std::vector< int >::value_type const & x)"""
+        return _libBornAgainFit.vector_integer_T_append(self, x)
 
     def empty(self):
-        r"""empty(vector_integer_t self) -> bool"""
-        return _libBornAgainFit.vector_integer_t_empty(self)
+        r"""empty(vector_integer_T self) -> bool"""
+        return _libBornAgainFit.vector_integer_T_empty(self)
 
     def size(self):
-        r"""size(vector_integer_t self) -> std::vector< int >::size_type"""
-        return _libBornAgainFit.vector_integer_t_size(self)
+        r"""size(vector_integer_T self) -> std::vector< int >::size_type"""
+        return _libBornAgainFit.vector_integer_T_size(self)
 
     def swap(self, v):
-        r"""swap(vector_integer_t self, vector_integer_t v)"""
-        return _libBornAgainFit.vector_integer_t_swap(self, v)
+        r"""swap(vector_integer_T self, vector_integer_T v)"""
+        return _libBornAgainFit.vector_integer_T_swap(self, v)
 
     def begin(self):
-        r"""begin(vector_integer_t self) -> std::vector< int >::iterator"""
-        return _libBornAgainFit.vector_integer_t_begin(self)
+        r"""begin(vector_integer_T self) -> std::vector< int >::iterator"""
+        return _libBornAgainFit.vector_integer_T_begin(self)
 
     def end(self):
-        r"""end(vector_integer_t self) -> std::vector< int >::iterator"""
-        return _libBornAgainFit.vector_integer_t_end(self)
+        r"""end(vector_integer_T self) -> std::vector< int >::iterator"""
+        return _libBornAgainFit.vector_integer_T_end(self)
 
     def rbegin(self):
-        r"""rbegin(vector_integer_t self) -> std::vector< int >::reverse_iterator"""
-        return _libBornAgainFit.vector_integer_t_rbegin(self)
+        r"""rbegin(vector_integer_T self) -> std::vector< int >::reverse_iterator"""
+        return _libBornAgainFit.vector_integer_T_rbegin(self)
 
     def rend(self):
-        r"""rend(vector_integer_t self) -> std::vector< int >::reverse_iterator"""
-        return _libBornAgainFit.vector_integer_t_rend(self)
+        r"""rend(vector_integer_T self) -> std::vector< int >::reverse_iterator"""
+        return _libBornAgainFit.vector_integer_T_rend(self)
 
     def clear(self):
-        r"""clear(vector_integer_t self)"""
-        return _libBornAgainFit.vector_integer_t_clear(self)
+        r"""clear(vector_integer_T self)"""
+        return _libBornAgainFit.vector_integer_T_clear(self)
 
     def get_allocator(self):
-        r"""get_allocator(vector_integer_t self) -> std::vector< int >::allocator_type"""
-        return _libBornAgainFit.vector_integer_t_get_allocator(self)
+        r"""get_allocator(vector_integer_T self) -> std::vector< int >::allocator_type"""
+        return _libBornAgainFit.vector_integer_T_get_allocator(self)
 
     def pop_back(self):
-        r"""pop_back(vector_integer_t self)"""
-        return _libBornAgainFit.vector_integer_t_pop_back(self)
+        r"""pop_back(vector_integer_T self)"""
+        return _libBornAgainFit.vector_integer_T_pop_back(self)
 
     def erase(self, *args):
         r"""
-        erase(vector_integer_t self, std::vector< int >::iterator pos) -> std::vector< int >::iterator
-        erase(vector_integer_t self, std::vector< int >::iterator first, std::vector< int >::iterator last) -> std::vector< int >::iterator
+        erase(vector_integer_T self, std::vector< int >::iterator pos) -> std::vector< int >::iterator
+        erase(vector_integer_T self, std::vector< int >::iterator first, std::vector< int >::iterator last) -> std::vector< int >::iterator
         """
-        return _libBornAgainFit.vector_integer_t_erase(self, *args)
+        return _libBornAgainFit.vector_integer_T_erase(self, *args)
 
     def __init__(self, *args):
         r"""
-        __init__(vector_integer_t self) -> vector_integer_t
-        __init__(vector_integer_t self, vector_integer_t other) -> vector_integer_t
-        __init__(vector_integer_t self, std::vector< int >::size_type size) -> vector_integer_t
-        __init__(vector_integer_t self, std::vector< int >::size_type size, std::vector< int >::value_type const & value) -> vector_integer_t
+        __init__(vector_integer_T self) -> vector_integer_T
+        __init__(vector_integer_T self, vector_integer_T other) -> vector_integer_T
+        __init__(vector_integer_T self, std::vector< int >::size_type size) -> vector_integer_T
+        __init__(vector_integer_T self, std::vector< int >::size_type size, std::vector< int >::value_type const & value) -> vector_integer_T
         """
-        _libBornAgainFit.vector_integer_t_swiginit(self, _libBornAgainFit.new_vector_integer_t(*args))
+        _libBornAgainFit.vector_integer_T_swiginit(self, _libBornAgainFit.new_vector_integer_T(*args))
 
     def push_back(self, x):
-        r"""push_back(vector_integer_t self, std::vector< int >::value_type const & x)"""
-        return _libBornAgainFit.vector_integer_t_push_back(self, x)
+        r"""push_back(vector_integer_T self, std::vector< int >::value_type const & x)"""
+        return _libBornAgainFit.vector_integer_T_push_back(self, x)
 
     def front(self):
-        r"""front(vector_integer_t self) -> std::vector< int >::value_type const &"""
-        return _libBornAgainFit.vector_integer_t_front(self)
+        r"""front(vector_integer_T self) -> std::vector< int >::value_type const &"""
+        return _libBornAgainFit.vector_integer_T_front(self)
 
     def back(self):
-        r"""back(vector_integer_t self) -> std::vector< int >::value_type const &"""
-        return _libBornAgainFit.vector_integer_t_back(self)
+        r"""back(vector_integer_T self) -> std::vector< int >::value_type const &"""
+        return _libBornAgainFit.vector_integer_T_back(self)
 
     def assign(self, n, x):
-        r"""assign(vector_integer_t self, std::vector< int >::size_type n, std::vector< int >::value_type const & x)"""
-        return _libBornAgainFit.vector_integer_t_assign(self, n, x)
+        r"""assign(vector_integer_T self, std::vector< int >::size_type n, std::vector< int >::value_type const & x)"""
+        return _libBornAgainFit.vector_integer_T_assign(self, n, x)
 
     def resize(self, *args):
         r"""
-        resize(vector_integer_t self, std::vector< int >::size_type new_size)
-        resize(vector_integer_t self, std::vector< int >::size_type new_size, std::vector< int >::value_type const & x)
+        resize(vector_integer_T self, std::vector< int >::size_type new_size)
+        resize(vector_integer_T self, std::vector< int >::size_type new_size, std::vector< int >::value_type const & x)
         """
-        return _libBornAgainFit.vector_integer_t_resize(self, *args)
+        return _libBornAgainFit.vector_integer_T_resize(self, *args)
 
     def insert(self, *args):
         r"""
-        insert(vector_integer_t self, std::vector< int >::iterator pos, std::vector< int >::value_type const & x) -> std::vector< int >::iterator
-        insert(vector_integer_t self, std::vector< int >::iterator pos, std::vector< int >::size_type n, std::vector< int >::value_type const & x)
+        insert(vector_integer_T self, std::vector< int >::iterator pos, std::vector< int >::value_type const & x) -> std::vector< int >::iterator
+        insert(vector_integer_T self, std::vector< int >::iterator pos, std::vector< int >::size_type n, std::vector< int >::value_type const & x)
         """
-        return _libBornAgainFit.vector_integer_t_insert(self, *args)
+        return _libBornAgainFit.vector_integer_T_insert(self, *args)
 
     def reserve(self, n):
-        r"""reserve(vector_integer_t self, std::vector< int >::size_type n)"""
-        return _libBornAgainFit.vector_integer_t_reserve(self, n)
+        r"""reserve(vector_integer_T self, std::vector< int >::size_type n)"""
+        return _libBornAgainFit.vector_integer_T_reserve(self, n)
 
     def capacity(self):
-        r"""capacity(vector_integer_t self) -> std::vector< int >::size_type"""
-        return _libBornAgainFit.vector_integer_t_capacity(self)
-    __swig_destroy__ = _libBornAgainFit.delete_vector_integer_t
+        r"""capacity(vector_integer_T self) -> std::vector< int >::size_type"""
+        return _libBornAgainFit.vector_integer_T_capacity(self)
+    __swig_destroy__ = _libBornAgainFit.delete_vector_integer_T
 
-# Register vector_integer_t in _libBornAgainFit:
-_libBornAgainFit.vector_integer_t_swigregister(vector_integer_t)
-class vinteger2d_t(object):
+# Register vector_integer_T in _libBornAgainFit:
+_libBornAgainFit.vector_integer_T_swigregister(vector_integer_T)
+class vinteger2d_T(object):
     r"""Proxy of C++ std::vector< std::vector< int > > class."""
 
     thisown = property(lambda x: x.this.own(), lambda x, v: x.this.own(v), doc="The membership flag")
     __repr__ = _swig_repr
 
     def iterator(self):
-        r"""iterator(vinteger2d_t self) -> SwigPyIterator"""
-        return _libBornAgainFit.vinteger2d_t_iterator(self)
+        r"""iterator(vinteger2d_T self) -> SwigPyIterator"""
+        return _libBornAgainFit.vinteger2d_T_iterator(self)
     def __iter__(self):
         return self.iterator()
 
     def __nonzero__(self):
-        r"""__nonzero__(vinteger2d_t self) -> bool"""
-        return _libBornAgainFit.vinteger2d_t___nonzero__(self)
+        r"""__nonzero__(vinteger2d_T self) -> bool"""
+        return _libBornAgainFit.vinteger2d_T___nonzero__(self)
 
     def __bool__(self):
-        r"""__bool__(vinteger2d_t self) -> bool"""
-        return _libBornAgainFit.vinteger2d_t___bool__(self)
+        r"""__bool__(vinteger2d_T self) -> bool"""
+        return _libBornAgainFit.vinteger2d_T___bool__(self)
 
     def __len__(self):
-        r"""__len__(vinteger2d_t self) -> std::vector< std::vector< int > >::size_type"""
-        return _libBornAgainFit.vinteger2d_t___len__(self)
+        r"""__len__(vinteger2d_T self) -> std::vector< std::vector< int > >::size_type"""
+        return _libBornAgainFit.vinteger2d_T___len__(self)
 
     def __getslice__(self, i, j):
-        r"""__getslice__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j) -> vinteger2d_t"""
-        return _libBornAgainFit.vinteger2d_t___getslice__(self, i, j)
+        r"""__getslice__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j) -> vinteger2d_T"""
+        return _libBornAgainFit.vinteger2d_T___getslice__(self, i, j)
 
     def __setslice__(self, *args):
         r"""
-        __setslice__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j)
-        __setslice__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j, vinteger2d_t v)
+        __setslice__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j)
+        __setslice__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j, vinteger2d_T v)
         """
-        return _libBornAgainFit.vinteger2d_t___setslice__(self, *args)
+        return _libBornAgainFit.vinteger2d_T___setslice__(self, *args)
 
     def __delslice__(self, i, j):
-        r"""__delslice__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j)"""
-        return _libBornAgainFit.vinteger2d_t___delslice__(self, i, j)
+        r"""__delslice__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j)"""
+        return _libBornAgainFit.vinteger2d_T___delslice__(self, i, j)
 
     def __delitem__(self, *args):
         r"""
-        __delitem__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i)
-        __delitem__(vinteger2d_t self, SWIGPY_SLICEOBJECT * slice)
+        __delitem__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i)
+        __delitem__(vinteger2d_T self, SWIGPY_SLICEOBJECT * slice)
         """
-        return _libBornAgainFit.vinteger2d_t___delitem__(self, *args)
+        return _libBornAgainFit.vinteger2d_T___delitem__(self, *args)
 
     def __getitem__(self, *args):
         r"""
-        __getitem__(vinteger2d_t self, SWIGPY_SLICEOBJECT * slice) -> vinteger2d_t
-        __getitem__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i) -> vector_integer_t
+        __getitem__(vinteger2d_T self, SWIGPY_SLICEOBJECT * slice) -> vinteger2d_T
+        __getitem__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i) -> vector_integer_T
         """
-        return _libBornAgainFit.vinteger2d_t___getitem__(self, *args)
+        return _libBornAgainFit.vinteger2d_T___getitem__(self, *args)
 
     def __setitem__(self, *args):
         r"""
-        __setitem__(vinteger2d_t self, SWIGPY_SLICEOBJECT * slice, vinteger2d_t v)
-        __setitem__(vinteger2d_t self, SWIGPY_SLICEOBJECT * slice)
-        __setitem__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i, vector_integer_t x)
+        __setitem__(vinteger2d_T self, SWIGPY_SLICEOBJECT * slice, vinteger2d_T v)
+        __setitem__(vinteger2d_T self, SWIGPY_SLICEOBJECT * slice)
+        __setitem__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i, vector_integer_T x)
         """
-        return _libBornAgainFit.vinteger2d_t___setitem__(self, *args)
+        return _libBornAgainFit.vinteger2d_T___setitem__(self, *args)
 
     def pop(self):
-        r"""pop(vinteger2d_t self) -> vector_integer_t"""
-        return _libBornAgainFit.vinteger2d_t_pop(self)
+        r"""pop(vinteger2d_T self) -> vector_integer_T"""
+        return _libBornAgainFit.vinteger2d_T_pop(self)
 
     def append(self, x):
-        r"""append(vinteger2d_t self, vector_integer_t x)"""
-        return _libBornAgainFit.vinteger2d_t_append(self, x)
+        r"""append(vinteger2d_T self, vector_integer_T x)"""
+        return _libBornAgainFit.vinteger2d_T_append(self, x)
 
     def empty(self):
-        r"""empty(vinteger2d_t self) -> bool"""
-        return _libBornAgainFit.vinteger2d_t_empty(self)
+        r"""empty(vinteger2d_T self) -> bool"""
+        return _libBornAgainFit.vinteger2d_T_empty(self)
 
     def size(self):
-        r"""size(vinteger2d_t self) -> std::vector< std::vector< int > >::size_type"""
-        return _libBornAgainFit.vinteger2d_t_size(self)
+        r"""size(vinteger2d_T self) -> std::vector< std::vector< int > >::size_type"""
+        return _libBornAgainFit.vinteger2d_T_size(self)
 
     def swap(self, v):
-        r"""swap(vinteger2d_t self, vinteger2d_t v)"""
-        return _libBornAgainFit.vinteger2d_t_swap(self, v)
+        r"""swap(vinteger2d_T self, vinteger2d_T v)"""
+        return _libBornAgainFit.vinteger2d_T_swap(self, v)
 
     def begin(self):
-        r"""begin(vinteger2d_t self) -> std::vector< std::vector< int > >::iterator"""
-        return _libBornAgainFit.vinteger2d_t_begin(self)
+        r"""begin(vinteger2d_T self) -> std::vector< std::vector< int > >::iterator"""
+        return _libBornAgainFit.vinteger2d_T_begin(self)
 
     def end(self):
-        r"""end(vinteger2d_t self) -> std::vector< std::vector< int > >::iterator"""
-        return _libBornAgainFit.vinteger2d_t_end(self)
+        r"""end(vinteger2d_T self) -> std::vector< std::vector< int > >::iterator"""
+        return _libBornAgainFit.vinteger2d_T_end(self)
 
     def rbegin(self):
-        r"""rbegin(vinteger2d_t self) -> std::vector< std::vector< int > >::reverse_iterator"""
-        return _libBornAgainFit.vinteger2d_t_rbegin(self)
+        r"""rbegin(vinteger2d_T self) -> std::vector< std::vector< int > >::reverse_iterator"""
+        return _libBornAgainFit.vinteger2d_T_rbegin(self)
 
     def rend(self):
-        r"""rend(vinteger2d_t self) -> std::vector< std::vector< int > >::reverse_iterator"""
-        return _libBornAgainFit.vinteger2d_t_rend(self)
+        r"""rend(vinteger2d_T self) -> std::vector< std::vector< int > >::reverse_iterator"""
+        return _libBornAgainFit.vinteger2d_T_rend(self)
 
     def clear(self):
-        r"""clear(vinteger2d_t self)"""
-        return _libBornAgainFit.vinteger2d_t_clear(self)
+        r"""clear(vinteger2d_T self)"""
+        return _libBornAgainFit.vinteger2d_T_clear(self)
 
     def get_allocator(self):
-        r"""get_allocator(vinteger2d_t self) -> std::vector< std::vector< int > >::allocator_type"""
-        return _libBornAgainFit.vinteger2d_t_get_allocator(self)
+        r"""get_allocator(vinteger2d_T self) -> std::vector< std::vector< int > >::allocator_type"""
+        return _libBornAgainFit.vinteger2d_T_get_allocator(self)
 
     def pop_back(self):
-        r"""pop_back(vinteger2d_t self)"""
-        return _libBornAgainFit.vinteger2d_t_pop_back(self)
+        r"""pop_back(vinteger2d_T self)"""
+        return _libBornAgainFit.vinteger2d_T_pop_back(self)
 
     def erase(self, *args):
         r"""
-        erase(vinteger2d_t self, std::vector< std::vector< int > >::iterator pos) -> std::vector< std::vector< int > >::iterator
-        erase(vinteger2d_t self, std::vector< std::vector< int > >::iterator first, std::vector< std::vector< int > >::iterator last) -> std::vector< std::vector< int > >::iterator
+        erase(vinteger2d_T self, std::vector< std::vector< int > >::iterator pos) -> std::vector< std::vector< int > >::iterator
+        erase(vinteger2d_T self, std::vector< std::vector< int > >::iterator first, std::vector< std::vector< int > >::iterator last) -> std::vector< std::vector< int > >::iterator
         """
-        return _libBornAgainFit.vinteger2d_t_erase(self, *args)
+        return _libBornAgainFit.vinteger2d_T_erase(self, *args)
 
     def __init__(self, *args):
         r"""
-        __init__(vinteger2d_t self) -> vinteger2d_t
-        __init__(vinteger2d_t self, vinteger2d_t other) -> vinteger2d_t
-        __init__(vinteger2d_t self, std::vector< std::vector< int > >::size_type size) -> vinteger2d_t
-        __init__(vinteger2d_t self, std::vector< std::vector< int > >::size_type size, vector_integer_t value) -> vinteger2d_t
+        __init__(vinteger2d_T self) -> vinteger2d_T
+        __init__(vinteger2d_T self, vinteger2d_T other) -> vinteger2d_T
+        __init__(vinteger2d_T self, std::vector< std::vector< int > >::size_type size) -> vinteger2d_T
+        __init__(vinteger2d_T self, std::vector< std::vector< int > >::size_type size, vector_integer_T value) -> vinteger2d_T
         """
-        _libBornAgainFit.vinteger2d_t_swiginit(self, _libBornAgainFit.new_vinteger2d_t(*args))
+        _libBornAgainFit.vinteger2d_T_swiginit(self, _libBornAgainFit.new_vinteger2d_T(*args))
 
     def push_back(self, x):
-        r"""push_back(vinteger2d_t self, vector_integer_t x)"""
-        return _libBornAgainFit.vinteger2d_t_push_back(self, x)
+        r"""push_back(vinteger2d_T self, vector_integer_T x)"""
+        return _libBornAgainFit.vinteger2d_T_push_back(self, x)
 
     def front(self):
-        r"""front(vinteger2d_t self) -> vector_integer_t"""
-        return _libBornAgainFit.vinteger2d_t_front(self)
+        r"""front(vinteger2d_T self) -> vector_integer_T"""
+        return _libBornAgainFit.vinteger2d_T_front(self)
 
     def back(self):
-        r"""back(vinteger2d_t self) -> vector_integer_t"""
-        return _libBornAgainFit.vinteger2d_t_back(self)
+        r"""back(vinteger2d_T self) -> vector_integer_T"""
+        return _libBornAgainFit.vinteger2d_T_back(self)
 
     def assign(self, n, x):
-        r"""assign(vinteger2d_t self, std::vector< std::vector< int > >::size_type n, vector_integer_t x)"""
-        return _libBornAgainFit.vinteger2d_t_assign(self, n, x)
+        r"""assign(vinteger2d_T self, std::vector< std::vector< int > >::size_type n, vector_integer_T x)"""
+        return _libBornAgainFit.vinteger2d_T_assign(self, n, x)
 
     def resize(self, *args):
         r"""
-        resize(vinteger2d_t self, std::vector< std::vector< int > >::size_type new_size)
-        resize(vinteger2d_t self, std::vector< std::vector< int > >::size_type new_size, vector_integer_t x)
+        resize(vinteger2d_T self, std::vector< std::vector< int > >::size_type new_size)
+        resize(vinteger2d_T self, std::vector< std::vector< int > >::size_type new_size, vector_integer_T x)
         """
-        return _libBornAgainFit.vinteger2d_t_resize(self, *args)
+        return _libBornAgainFit.vinteger2d_T_resize(self, *args)
 
     def insert(self, *args):
         r"""
-        insert(vinteger2d_t self, std::vector< std::vector< int > >::iterator pos, vector_integer_t x) -> std::vector< std::vector< int > >::iterator
-        insert(vinteger2d_t self, std::vector< std::vector< int > >::iterator pos, std::vector< std::vector< int > >::size_type n, vector_integer_t x)
+        insert(vinteger2d_T self, std::vector< std::vector< int > >::iterator pos, vector_integer_T x) -> std::vector< std::vector< int > >::iterator
+        insert(vinteger2d_T self, std::vector< std::vector< int > >::iterator pos, std::vector< std::vector< int > >::size_type n, vector_integer_T x)
         """
-        return _libBornAgainFit.vinteger2d_t_insert(self, *args)
+        return _libBornAgainFit.vinteger2d_T_insert(self, *args)
 
     def reserve(self, n):
-        r"""reserve(vinteger2d_t self, std::vector< std::vector< int > >::size_type n)"""
-        return _libBornAgainFit.vinteger2d_t_reserve(self, n)
+        r"""reserve(vinteger2d_T self, std::vector< std::vector< int > >::size_type n)"""
+        return _libBornAgainFit.vinteger2d_T_reserve(self, n)
 
     def capacity(self):
-        r"""capacity(vinteger2d_t self) -> std::vector< std::vector< int > >::size_type"""
-        return _libBornAgainFit.vinteger2d_t_capacity(self)
-    __swig_destroy__ = _libBornAgainFit.delete_vinteger2d_t
+        r"""capacity(vinteger2d_T self) -> std::vector< std::vector< int > >::size_type"""
+        return _libBornAgainFit.vinteger2d_T_capacity(self)
+    __swig_destroy__ = _libBornAgainFit.delete_vinteger2d_T
 
-# Register vinteger2d_t in _libBornAgainFit:
-_libBornAgainFit.vinteger2d_t_swigregister(vinteger2d_t)
-class vector_longinteger_t(object):
+# Register vinteger2d_T in _libBornAgainFit:
+_libBornAgainFit.vinteger2d_T_swigregister(vinteger2d_T)
+class vector_longinteger_T(object):
     r"""Proxy of C++ std::vector< unsigned long > class."""
 
     thisown = property(lambda x: x.this.own(), lambda x, v: x.this.own(v), doc="The membership flag")
     __repr__ = _swig_repr
 
     def iterator(self):
-        r"""iterator(vector_longinteger_t self) -> SwigPyIterator"""
-        return _libBornAgainFit.vector_longinteger_t_iterator(self)
+        r"""iterator(vector_longinteger_T self) -> SwigPyIterator"""
+        return _libBornAgainFit.vector_longinteger_T_iterator(self)
     def __iter__(self):
         return self.iterator()
 
     def __nonzero__(self):
-        r"""__nonzero__(vector_longinteger_t self) -> bool"""
-        return _libBornAgainFit.vector_longinteger_t___nonzero__(self)
+        r"""__nonzero__(vector_longinteger_T self) -> bool"""
+        return _libBornAgainFit.vector_longinteger_T___nonzero__(self)
 
     def __bool__(self):
-        r"""__bool__(vector_longinteger_t self) -> bool"""
-        return _libBornAgainFit.vector_longinteger_t___bool__(self)
+        r"""__bool__(vector_longinteger_T self) -> bool"""
+        return _libBornAgainFit.vector_longinteger_T___bool__(self)
 
     def __len__(self):
-        r"""__len__(vector_longinteger_t self) -> std::vector< unsigned long >::size_type"""
-        return _libBornAgainFit.vector_longinteger_t___len__(self)
+        r"""__len__(vector_longinteger_T self) -> std::vector< unsigned long >::size_type"""
+        return _libBornAgainFit.vector_longinteger_T___len__(self)
 
     def __getslice__(self, i, j):
-        r"""__getslice__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j) -> vector_longinteger_t"""
-        return _libBornAgainFit.vector_longinteger_t___getslice__(self, i, j)
+        r"""__getslice__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j) -> vector_longinteger_T"""
+        return _libBornAgainFit.vector_longinteger_T___getslice__(self, i, j)
 
     def __setslice__(self, *args):
         r"""
-        __setslice__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j)
-        __setslice__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j, vector_longinteger_t v)
+        __setslice__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j)
+        __setslice__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j, vector_longinteger_T v)
         """
-        return _libBornAgainFit.vector_longinteger_t___setslice__(self, *args)
+        return _libBornAgainFit.vector_longinteger_T___setslice__(self, *args)
 
     def __delslice__(self, i, j):
-        r"""__delslice__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j)"""
-        return _libBornAgainFit.vector_longinteger_t___delslice__(self, i, j)
+        r"""__delslice__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j)"""
+        return _libBornAgainFit.vector_longinteger_T___delslice__(self, i, j)
 
     def __delitem__(self, *args):
         r"""
-        __delitem__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i)
-        __delitem__(vector_longinteger_t self, SWIGPY_SLICEOBJECT * slice)
+        __delitem__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i)
+        __delitem__(vector_longinteger_T self, SWIGPY_SLICEOBJECT * slice)
         """
-        return _libBornAgainFit.vector_longinteger_t___delitem__(self, *args)
+        return _libBornAgainFit.vector_longinteger_T___delitem__(self, *args)
 
     def __getitem__(self, *args):
         r"""
-        __getitem__(vector_longinteger_t self, SWIGPY_SLICEOBJECT * slice) -> vector_longinteger_t
-        __getitem__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i) -> std::vector< unsigned long >::value_type const &
+        __getitem__(vector_longinteger_T self, SWIGPY_SLICEOBJECT * slice) -> vector_longinteger_T
+        __getitem__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i) -> std::vector< unsigned long >::value_type const &
         """
-        return _libBornAgainFit.vector_longinteger_t___getitem__(self, *args)
+        return _libBornAgainFit.vector_longinteger_T___getitem__(self, *args)
 
     def __setitem__(self, *args):
         r"""
-        __setitem__(vector_longinteger_t self, SWIGPY_SLICEOBJECT * slice, vector_longinteger_t v)
-        __setitem__(vector_longinteger_t self, SWIGPY_SLICEOBJECT * slice)
-        __setitem__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::value_type const & x)
+        __setitem__(vector_longinteger_T self, SWIGPY_SLICEOBJECT * slice, vector_longinteger_T v)
+        __setitem__(vector_longinteger_T self, SWIGPY_SLICEOBJECT * slice)
+        __setitem__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::value_type const & x)
         """
-        return _libBornAgainFit.vector_longinteger_t___setitem__(self, *args)
+        return _libBornAgainFit.vector_longinteger_T___setitem__(self, *args)
 
     def pop(self):
-        r"""pop(vector_longinteger_t self) -> std::vector< unsigned long >::value_type"""
-        return _libBornAgainFit.vector_longinteger_t_pop(self)
+        r"""pop(vector_longinteger_T self) -> std::vector< unsigned long >::value_type"""
+        return _libBornAgainFit.vector_longinteger_T_pop(self)
 
     def append(self, x):
-        r"""append(vector_longinteger_t self, std::vector< unsigned long >::value_type const & x)"""
-        return _libBornAgainFit.vector_longinteger_t_append(self, x)
+        r"""append(vector_longinteger_T self, std::vector< unsigned long >::value_type const & x)"""
+        return _libBornAgainFit.vector_longinteger_T_append(self, x)
 
     def empty(self):
-        r"""empty(vector_longinteger_t self) -> bool"""
-        return _libBornAgainFit.vector_longinteger_t_empty(self)
+        r"""empty(vector_longinteger_T self) -> bool"""
+        return _libBornAgainFit.vector_longinteger_T_empty(self)
 
     def size(self):
-        r"""size(vector_longinteger_t self) -> std::vector< unsigned long >::size_type"""
-        return _libBornAgainFit.vector_longinteger_t_size(self)
+        r"""size(vector_longinteger_T self) -> std::vector< unsigned long >::size_type"""
+        return _libBornAgainFit.vector_longinteger_T_size(self)
 
     def swap(self, v):
-        r"""swap(vector_longinteger_t self, vector_longinteger_t v)"""
-        return _libBornAgainFit.vector_longinteger_t_swap(self, v)
+        r"""swap(vector_longinteger_T self, vector_longinteger_T v)"""
+        return _libBornAgainFit.vector_longinteger_T_swap(self, v)
 
     def begin(self):
-        r"""begin(vector_longinteger_t self) -> std::vector< unsigned long >::iterator"""
-        return _libBornAgainFit.vector_longinteger_t_begin(self)
+        r"""begin(vector_longinteger_T self) -> std::vector< unsigned long >::iterator"""
+        return _libBornAgainFit.vector_longinteger_T_begin(self)
 
     def end(self):
-        r"""end(vector_longinteger_t self) -> std::vector< unsigned long >::iterator"""
-        return _libBornAgainFit.vector_longinteger_t_end(self)
+        r"""end(vector_longinteger_T self) -> std::vector< unsigned long >::iterator"""
+        return _libBornAgainFit.vector_longinteger_T_end(self)
 
     def rbegin(self):
-        r"""rbegin(vector_longinteger_t self) -> std::vector< unsigned long >::reverse_iterator"""
-        return _libBornAgainFit.vector_longinteger_t_rbegin(self)
+        r"""rbegin(vector_longinteger_T self) -> std::vector< unsigned long >::reverse_iterator"""
+        return _libBornAgainFit.vector_longinteger_T_rbegin(self)
 
     def rend(self):
-        r"""rend(vector_longinteger_t self) -> std::vector< unsigned long >::reverse_iterator"""
-        return _libBornAgainFit.vector_longinteger_t_rend(self)
+        r"""rend(vector_longinteger_T self) -> std::vector< unsigned long >::reverse_iterator"""
+        return _libBornAgainFit.vector_longinteger_T_rend(self)
 
     def clear(self):
-        r"""clear(vector_longinteger_t self)"""
-        return _libBornAgainFit.vector_longinteger_t_clear(self)
+        r"""clear(vector_longinteger_T self)"""
+        return _libBornAgainFit.vector_longinteger_T_clear(self)
 
     def get_allocator(self):
-        r"""get_allocator(vector_longinteger_t self) -> std::vector< unsigned long >::allocator_type"""
-        return _libBornAgainFit.vector_longinteger_t_get_allocator(self)
+        r"""get_allocator(vector_longinteger_T self) -> std::vector< unsigned long >::allocator_type"""
+        return _libBornAgainFit.vector_longinteger_T_get_allocator(self)
 
     def pop_back(self):
-        r"""pop_back(vector_longinteger_t self)"""
-        return _libBornAgainFit.vector_longinteger_t_pop_back(self)
+        r"""pop_back(vector_longinteger_T self)"""
+        return _libBornAgainFit.vector_longinteger_T_pop_back(self)
 
     def erase(self, *args):
         r"""
-        erase(vector_longinteger_t self, std::vector< unsigned long >::iterator pos) -> std::vector< unsigned long >::iterator
-        erase(vector_longinteger_t self, std::vector< unsigned long >::iterator first, std::vector< unsigned long >::iterator last) -> std::vector< unsigned long >::iterator
+        erase(vector_longinteger_T self, std::vector< unsigned long >::iterator pos) -> std::vector< unsigned long >::iterator
+        erase(vector_longinteger_T self, std::vector< unsigned long >::iterator first, std::vector< unsigned long >::iterator last) -> std::vector< unsigned long >::iterator
         """
-        return _libBornAgainFit.vector_longinteger_t_erase(self, *args)
+        return _libBornAgainFit.vector_longinteger_T_erase(self, *args)
 
     def __init__(self, *args):
         r"""
-        __init__(vector_longinteger_t self) -> vector_longinteger_t
-        __init__(vector_longinteger_t self, vector_longinteger_t other) -> vector_longinteger_t
-        __init__(vector_longinteger_t self, std::vector< unsigned long >::size_type size) -> vector_longinteger_t
-        __init__(vector_longinteger_t self, std::vector< unsigned long >::size_type size, std::vector< unsigned long >::value_type const & value) -> vector_longinteger_t
+        __init__(vector_longinteger_T self) -> vector_longinteger_T
+        __init__(vector_longinteger_T self, vector_longinteger_T other) -> vector_longinteger_T
+        __init__(vector_longinteger_T self, std::vector< unsigned long >::size_type size) -> vector_longinteger_T
+        __init__(vector_longinteger_T self, std::vector< unsigned long >::size_type size, std::vector< unsigned long >::value_type const & value) -> vector_longinteger_T
         """
-        _libBornAgainFit.vector_longinteger_t_swiginit(self, _libBornAgainFit.new_vector_longinteger_t(*args))
+        _libBornAgainFit.vector_longinteger_T_swiginit(self, _libBornAgainFit.new_vector_longinteger_T(*args))
 
     def push_back(self, x):
-        r"""push_back(vector_longinteger_t self, std::vector< unsigned long >::value_type const & x)"""
-        return _libBornAgainFit.vector_longinteger_t_push_back(self, x)
+        r"""push_back(vector_longinteger_T self, std::vector< unsigned long >::value_type const & x)"""
+        return _libBornAgainFit.vector_longinteger_T_push_back(self, x)
 
     def front(self):
-        r"""front(vector_longinteger_t self) -> std::vector< unsigned long >::value_type const &"""
-        return _libBornAgainFit.vector_longinteger_t_front(self)
+        r"""front(vector_longinteger_T self) -> std::vector< unsigned long >::value_type const &"""
+        return _libBornAgainFit.vector_longinteger_T_front(self)
 
     def back(self):
-        r"""back(vector_longinteger_t self) -> std::vector< unsigned long >::value_type const &"""
-        return _libBornAgainFit.vector_longinteger_t_back(self)
+        r"""back(vector_longinteger_T self) -> std::vector< unsigned long >::value_type const &"""
+        return _libBornAgainFit.vector_longinteger_T_back(self)
 
     def assign(self, n, x):
-        r"""assign(vector_longinteger_t self, std::vector< unsigned long >::size_type n, std::vector< unsigned long >::value_type const & x)"""
-        return _libBornAgainFit.vector_longinteger_t_assign(self, n, x)
+        r"""assign(vector_longinteger_T self, std::vector< unsigned long >::size_type n, std::vector< unsigned long >::value_type const & x)"""
+        return _libBornAgainFit.vector_longinteger_T_assign(self, n, x)
 
     def resize(self, *args):
         r"""
-        resize(vector_longinteger_t self, std::vector< unsigned long >::size_type new_size)
-        resize(vector_longinteger_t self, std::vector< unsigned long >::size_type new_size, std::vector< unsigned long >::value_type const & x)
+        resize(vector_longinteger_T self, std::vector< unsigned long >::size_type new_size)
+        resize(vector_longinteger_T self, std::vector< unsigned long >::size_type new_size, std::vector< unsigned long >::value_type const & x)
         """
-        return _libBornAgainFit.vector_longinteger_t_resize(self, *args)
+        return _libBornAgainFit.vector_longinteger_T_resize(self, *args)
 
     def insert(self, *args):
         r"""
-        insert(vector_longinteger_t self, std::vector< unsigned long >::iterator pos, std::vector< unsigned long >::value_type const & x) -> std::vector< unsigned long >::iterator
-        insert(vector_longinteger_t self, std::vector< unsigned long >::iterator pos, std::vector< unsigned long >::size_type n, std::vector< unsigned long >::value_type const & x)
+        insert(vector_longinteger_T self, std::vector< unsigned long >::iterator pos, std::vector< unsigned long >::value_type const & x) -> std::vector< unsigned long >::iterator
+        insert(vector_longinteger_T self, std::vector< unsigned long >::iterator pos, std::vector< unsigned long >::size_type n, std::vector< unsigned long >::value_type const & x)
         """
-        return _libBornAgainFit.vector_longinteger_t_insert(self, *args)
+        return _libBornAgainFit.vector_longinteger_T_insert(self, *args)
 
     def reserve(self, n):
-        r"""reserve(vector_longinteger_t self, std::vector< unsigned long >::size_type n)"""
-        return _libBornAgainFit.vector_longinteger_t_reserve(self, n)
+        r"""reserve(vector_longinteger_T self, std::vector< unsigned long >::size_type n)"""
+        return _libBornAgainFit.vector_longinteger_T_reserve(self, n)
 
     def capacity(self):
-        r"""capacity(vector_longinteger_t self) -> std::vector< unsigned long >::size_type"""
-        return _libBornAgainFit.vector_longinteger_t_capacity(self)
-    __swig_destroy__ = _libBornAgainFit.delete_vector_longinteger_t
+        r"""capacity(vector_longinteger_T self) -> std::vector< unsigned long >::size_type"""
+        return _libBornAgainFit.vector_longinteger_T_capacity(self)
+    __swig_destroy__ = _libBornAgainFit.delete_vector_longinteger_T
 
-# Register vector_longinteger_t in _libBornAgainFit:
-_libBornAgainFit.vector_longinteger_t_swigregister(vector_longinteger_t)
-class vector_complex_t(object):
+# Register vector_longinteger_T in _libBornAgainFit:
+_libBornAgainFit.vector_longinteger_T_swigregister(vector_longinteger_T)
+class vector_complex_T(object):
     r"""Proxy of C++ std::vector< std::complex< double > > class."""
 
     thisown = property(lambda x: x.this.own(), lambda x, v: x.this.own(v), doc="The membership flag")
     __repr__ = _swig_repr
 
     def iterator(self):
-        r"""iterator(vector_complex_t self) -> SwigPyIterator"""
-        return _libBornAgainFit.vector_complex_t_iterator(self)
+        r"""iterator(vector_complex_T self) -> SwigPyIterator"""
+        return _libBornAgainFit.vector_complex_T_iterator(self)
     def __iter__(self):
         return self.iterator()
 
     def __nonzero__(self):
-        r"""__nonzero__(vector_complex_t self) -> bool"""
-        return _libBornAgainFit.vector_complex_t___nonzero__(self)
+        r"""__nonzero__(vector_complex_T self) -> bool"""
+        return _libBornAgainFit.vector_complex_T___nonzero__(self)
 
     def __bool__(self):
-        r"""__bool__(vector_complex_t self) -> bool"""
-        return _libBornAgainFit.vector_complex_t___bool__(self)
+        r"""__bool__(vector_complex_T self) -> bool"""
+        return _libBornAgainFit.vector_complex_T___bool__(self)
 
     def __len__(self):
-        r"""__len__(vector_complex_t self) -> std::vector< std::complex< double > >::size_type"""
-        return _libBornAgainFit.vector_complex_t___len__(self)
+        r"""__len__(vector_complex_T self) -> std::vector< std::complex< double > >::size_type"""
+        return _libBornAgainFit.vector_complex_T___len__(self)
 
     def __getslice__(self, i, j):
-        r"""__getslice__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j) -> vector_complex_t"""
-        return _libBornAgainFit.vector_complex_t___getslice__(self, i, j)
+        r"""__getslice__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j) -> vector_complex_T"""
+        return _libBornAgainFit.vector_complex_T___getslice__(self, i, j)
 
     def __setslice__(self, *args):
         r"""
-        __setslice__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j)
-        __setslice__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j, vector_complex_t v)
+        __setslice__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j)
+        __setslice__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j, vector_complex_T v)
         """
-        return _libBornAgainFit.vector_complex_t___setslice__(self, *args)
+        return _libBornAgainFit.vector_complex_T___setslice__(self, *args)
 
     def __delslice__(self, i, j):
-        r"""__delslice__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j)"""
-        return _libBornAgainFit.vector_complex_t___delslice__(self, i, j)
+        r"""__delslice__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j)"""
+        return _libBornAgainFit.vector_complex_T___delslice__(self, i, j)
 
     def __delitem__(self, *args):
         r"""
-        __delitem__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i)
-        __delitem__(vector_complex_t self, SWIGPY_SLICEOBJECT * slice)
+        __delitem__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i)
+        __delitem__(vector_complex_T self, SWIGPY_SLICEOBJECT * slice)
         """
-        return _libBornAgainFit.vector_complex_t___delitem__(self, *args)
+        return _libBornAgainFit.vector_complex_T___delitem__(self, *args)
 
     def __getitem__(self, *args):
         r"""
-        __getitem__(vector_complex_t self, SWIGPY_SLICEOBJECT * slice) -> vector_complex_t
-        __getitem__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i) -> std::vector< std::complex< double > >::value_type const &
+        __getitem__(vector_complex_T self, SWIGPY_SLICEOBJECT * slice) -> vector_complex_T
+        __getitem__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i) -> std::vector< std::complex< double > >::value_type const &
         """
-        return _libBornAgainFit.vector_complex_t___getitem__(self, *args)
+        return _libBornAgainFit.vector_complex_T___getitem__(self, *args)
 
     def __setitem__(self, *args):
         r"""
-        __setitem__(vector_complex_t self, SWIGPY_SLICEOBJECT * slice, vector_complex_t v)
-        __setitem__(vector_complex_t self, SWIGPY_SLICEOBJECT * slice)
-        __setitem__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::value_type const & x)
+        __setitem__(vector_complex_T self, SWIGPY_SLICEOBJECT * slice, vector_complex_T v)
+        __setitem__(vector_complex_T self, SWIGPY_SLICEOBJECT * slice)
+        __setitem__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::value_type const & x)
         """
-        return _libBornAgainFit.vector_complex_t___setitem__(self, *args)
+        return _libBornAgainFit.vector_complex_T___setitem__(self, *args)
 
     def pop(self):
-        r"""pop(vector_complex_t self) -> std::vector< std::complex< double > >::value_type"""
-        return _libBornAgainFit.vector_complex_t_pop(self)
+        r"""pop(vector_complex_T self) -> std::vector< std::complex< double > >::value_type"""
+        return _libBornAgainFit.vector_complex_T_pop(self)
 
     def append(self, x):
-        r"""append(vector_complex_t self, std::vector< std::complex< double > >::value_type const & x)"""
-        return _libBornAgainFit.vector_complex_t_append(self, x)
+        r"""append(vector_complex_T self, std::vector< std::complex< double > >::value_type const & x)"""
+        return _libBornAgainFit.vector_complex_T_append(self, x)
 
     def empty(self):
-        r"""empty(vector_complex_t self) -> bool"""
-        return _libBornAgainFit.vector_complex_t_empty(self)
+        r"""empty(vector_complex_T self) -> bool"""
+        return _libBornAgainFit.vector_complex_T_empty(self)
 
     def size(self):
-        r"""size(vector_complex_t self) -> std::vector< std::complex< double > >::size_type"""
-        return _libBornAgainFit.vector_complex_t_size(self)
+        r"""size(vector_complex_T self) -> std::vector< std::complex< double > >::size_type"""
+        return _libBornAgainFit.vector_complex_T_size(self)
 
     def swap(self, v):
-        r"""swap(vector_complex_t self, vector_complex_t v)"""
-        return _libBornAgainFit.vector_complex_t_swap(self, v)
+        r"""swap(vector_complex_T self, vector_complex_T v)"""
+        return _libBornAgainFit.vector_complex_T_swap(self, v)
 
     def begin(self):
-        r"""begin(vector_complex_t self) -> std::vector< std::complex< double > >::iterator"""
-        return _libBornAgainFit.vector_complex_t_begin(self)
+        r"""begin(vector_complex_T self) -> std::vector< std::complex< double > >::iterator"""
+        return _libBornAgainFit.vector_complex_T_begin(self)
 
     def end(self):
-        r"""end(vector_complex_t self) -> std::vector< std::complex< double > >::iterator"""
-        return _libBornAgainFit.vector_complex_t_end(self)
+        r"""end(vector_complex_T self) -> std::vector< std::complex< double > >::iterator"""
+        return _libBornAgainFit.vector_complex_T_end(self)
 
     def rbegin(self):
-        r"""rbegin(vector_complex_t self) -> std::vector< std::complex< double > >::reverse_iterator"""
-        return _libBornAgainFit.vector_complex_t_rbegin(self)
+        r"""rbegin(vector_complex_T self) -> std::vector< std::complex< double > >::reverse_iterator"""
+        return _libBornAgainFit.vector_complex_T_rbegin(self)
 
     def rend(self):
-        r"""rend(vector_complex_t self) -> std::vector< std::complex< double > >::reverse_iterator"""
-        return _libBornAgainFit.vector_complex_t_rend(self)
+        r"""rend(vector_complex_T self) -> std::vector< std::complex< double > >::reverse_iterator"""
+        return _libBornAgainFit.vector_complex_T_rend(self)
 
     def clear(self):
-        r"""clear(vector_complex_t self)"""
-        return _libBornAgainFit.vector_complex_t_clear(self)
+        r"""clear(vector_complex_T self)"""
+        return _libBornAgainFit.vector_complex_T_clear(self)
 
     def get_allocator(self):
-        r"""get_allocator(vector_complex_t self) -> std::vector< std::complex< double > >::allocator_type"""
-        return _libBornAgainFit.vector_complex_t_get_allocator(self)
+        r"""get_allocator(vector_complex_T self) -> std::vector< std::complex< double > >::allocator_type"""
+        return _libBornAgainFit.vector_complex_T_get_allocator(self)
 
     def pop_back(self):
-        r"""pop_back(vector_complex_t self)"""
-        return _libBornAgainFit.vector_complex_t_pop_back(self)
+        r"""pop_back(vector_complex_T self)"""
+        return _libBornAgainFit.vector_complex_T_pop_back(self)
 
     def erase(self, *args):
         r"""
-        erase(vector_complex_t self, std::vector< std::complex< double > >::iterator pos) -> std::vector< std::complex< double > >::iterator
-        erase(vector_complex_t self, std::vector< std::complex< double > >::iterator first, std::vector< std::complex< double > >::iterator last) -> std::vector< std::complex< double > >::iterator
+        erase(vector_complex_T self, std::vector< std::complex< double > >::iterator pos) -> std::vector< std::complex< double > >::iterator
+        erase(vector_complex_T self, std::vector< std::complex< double > >::iterator first, std::vector< std::complex< double > >::iterator last) -> std::vector< std::complex< double > >::iterator
         """
-        return _libBornAgainFit.vector_complex_t_erase(self, *args)
+        return _libBornAgainFit.vector_complex_T_erase(self, *args)
 
     def __init__(self, *args):
         r"""
-        __init__(vector_complex_t self) -> vector_complex_t
-        __init__(vector_complex_t self, vector_complex_t other) -> vector_complex_t
-        __init__(vector_complex_t self, std::vector< std::complex< double > >::size_type size) -> vector_complex_t
-        __init__(vector_complex_t self, std::vector< std::complex< double > >::size_type size, std::vector< std::complex< double > >::value_type const & value) -> vector_complex_t
+        __init__(vector_complex_T self) -> vector_complex_T
+        __init__(vector_complex_T self, vector_complex_T other) -> vector_complex_T
+        __init__(vector_complex_T self, std::vector< std::complex< double > >::size_type size) -> vector_complex_T
+        __init__(vector_complex_T self, std::vector< std::complex< double > >::size_type size, std::vector< std::complex< double > >::value_type const & value) -> vector_complex_T
         """
-        _libBornAgainFit.vector_complex_t_swiginit(self, _libBornAgainFit.new_vector_complex_t(*args))
+        _libBornAgainFit.vector_complex_T_swiginit(self, _libBornAgainFit.new_vector_complex_T(*args))
 
     def push_back(self, x):
-        r"""push_back(vector_complex_t self, std::vector< std::complex< double > >::value_type const & x)"""
-        return _libBornAgainFit.vector_complex_t_push_back(self, x)
+        r"""push_back(vector_complex_T self, std::vector< std::complex< double > >::value_type const & x)"""
+        return _libBornAgainFit.vector_complex_T_push_back(self, x)
 
     def front(self):
-        r"""front(vector_complex_t self) -> std::vector< std::complex< double > >::value_type const &"""
-        return _libBornAgainFit.vector_complex_t_front(self)
+        r"""front(vector_complex_T self) -> std::vector< std::complex< double > >::value_type const &"""
+        return _libBornAgainFit.vector_complex_T_front(self)
 
     def back(self):
-        r"""back(vector_complex_t self) -> std::vector< std::complex< double > >::value_type const &"""
-        return _libBornAgainFit.vector_complex_t_back(self)
+        r"""back(vector_complex_T self) -> std::vector< std::complex< double > >::value_type const &"""
+        return _libBornAgainFit.vector_complex_T_back(self)
 
     def assign(self, n, x):
-        r"""assign(vector_complex_t self, std::vector< std::complex< double > >::size_type n, std::vector< std::complex< double > >::value_type const & x)"""
-        return _libBornAgainFit.vector_complex_t_assign(self, n, x)
+        r"""assign(vector_complex_T self, std::vector< std::complex< double > >::size_type n, std::vector< std::complex< double > >::value_type const & x)"""
+        return _libBornAgainFit.vector_complex_T_assign(self, n, x)
 
     def resize(self, *args):
         r"""
-        resize(vector_complex_t self, std::vector< std::complex< double > >::size_type new_size)
-        resize(vector_complex_t self, std::vector< std::complex< double > >::size_type new_size, std::vector< std::complex< double > >::value_type const & x)
+        resize(vector_complex_T self, std::vector< std::complex< double > >::size_type new_size)
+        resize(vector_complex_T self, std::vector< std::complex< double > >::size_type new_size, std::vector< std::complex< double > >::value_type const & x)
         """
-        return _libBornAgainFit.vector_complex_t_resize(self, *args)
+        return _libBornAgainFit.vector_complex_T_resize(self, *args)
 
     def insert(self, *args):
         r"""
-        insert(vector_complex_t self, std::vector< std::complex< double > >::iterator pos, std::vector< std::complex< double > >::value_type const & x) -> std::vector< std::complex< double > >::iterator
-        insert(vector_complex_t self, std::vector< std::complex< double > >::iterator pos, std::vector< std::complex< double > >::size_type n, std::vector< std::complex< double > >::value_type const & x)
+        insert(vector_complex_T self, std::vector< std::complex< double > >::iterator pos, std::vector< std::complex< double > >::value_type const & x) -> std::vector< std::complex< double > >::iterator
+        insert(vector_complex_T self, std::vector< std::complex< double > >::iterator pos, std::vector< std::complex< double > >::size_type n, std::vector< std::complex< double > >::value_type const & x)
         """
-        return _libBornAgainFit.vector_complex_t_insert(self, *args)
+        return _libBornAgainFit.vector_complex_T_insert(self, *args)
 
     def reserve(self, n):
-        r"""reserve(vector_complex_t self, std::vector< std::complex< double > >::size_type n)"""
-        return _libBornAgainFit.vector_complex_t_reserve(self, n)
+        r"""reserve(vector_complex_T self, std::vector< std::complex< double > >::size_type n)"""
+        return _libBornAgainFit.vector_complex_T_reserve(self, n)
 
     def capacity(self):
-        r"""capacity(vector_complex_t self) -> std::vector< std::complex< double > >::size_type"""
-        return _libBornAgainFit.vector_complex_t_capacity(self)
-    __swig_destroy__ = _libBornAgainFit.delete_vector_complex_t
+        r"""capacity(vector_complex_T self) -> std::vector< std::complex< double > >::size_type"""
+        return _libBornAgainFit.vector_complex_T_capacity(self)
+    __swig_destroy__ = _libBornAgainFit.delete_vector_complex_T
 
-# Register vector_complex_t in _libBornAgainFit:
-_libBornAgainFit.vector_complex_t_swigregister(vector_complex_t)
-class vector_string_t(object):
+# Register vector_complex_T in _libBornAgainFit:
+_libBornAgainFit.vector_complex_T_swigregister(vector_complex_T)
+class vector_string_T(object):
     r"""Proxy of C++ std::vector< std::string > class."""
 
     thisown = property(lambda x: x.this.own(), lambda x, v: x.this.own(v), doc="The membership flag")
     __repr__ = _swig_repr
 
     def iterator(self):
-        r"""iterator(vector_string_t self) -> SwigPyIterator"""
-        return _libBornAgainFit.vector_string_t_iterator(self)
+        r"""iterator(vector_string_T self) -> SwigPyIterator"""
+        return _libBornAgainFit.vector_string_T_iterator(self)
     def __iter__(self):
         return self.iterator()
 
     def __nonzero__(self):
-        r"""__nonzero__(vector_string_t self) -> bool"""
-        return _libBornAgainFit.vector_string_t___nonzero__(self)
+        r"""__nonzero__(vector_string_T self) -> bool"""
+        return _libBornAgainFit.vector_string_T___nonzero__(self)
 
     def __bool__(self):
-        r"""__bool__(vector_string_t self) -> bool"""
-        return _libBornAgainFit.vector_string_t___bool__(self)
+        r"""__bool__(vector_string_T self) -> bool"""
+        return _libBornAgainFit.vector_string_T___bool__(self)
 
     def __len__(self):
-        r"""__len__(vector_string_t self) -> std::vector< std::string >::size_type"""
-        return _libBornAgainFit.vector_string_t___len__(self)
+        r"""__len__(vector_string_T self) -> std::vector< std::string >::size_type"""
+        return _libBornAgainFit.vector_string_T___len__(self)
 
     def __getslice__(self, i, j):
-        r"""__getslice__(vector_string_t self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j) -> vector_string_t"""
-        return _libBornAgainFit.vector_string_t___getslice__(self, i, j)
+        r"""__getslice__(vector_string_T self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j) -> vector_string_T"""
+        return _libBornAgainFit.vector_string_T___getslice__(self, i, j)
 
     def __setslice__(self, *args):
         r"""
-        __setslice__(vector_string_t self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j)
-        __setslice__(vector_string_t self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j, vector_string_t v)
+        __setslice__(vector_string_T self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j)
+        __setslice__(vector_string_T self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j, vector_string_T v)
         """
-        return _libBornAgainFit.vector_string_t___setslice__(self, *args)
+        return _libBornAgainFit.vector_string_T___setslice__(self, *args)
 
     def __delslice__(self, i, j):
-        r"""__delslice__(vector_string_t self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j)"""
-        return _libBornAgainFit.vector_string_t___delslice__(self, i, j)
+        r"""__delslice__(vector_string_T self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j)"""
+        return _libBornAgainFit.vector_string_T___delslice__(self, i, j)
 
     def __delitem__(self, *args):
         r"""
-        __delitem__(vector_string_t self, std::vector< std::string >::difference_type i)
-        __delitem__(vector_string_t self, SWIGPY_SLICEOBJECT * slice)
+        __delitem__(vector_string_T self, std::vector< std::string >::difference_type i)
+        __delitem__(vector_string_T self, SWIGPY_SLICEOBJECT * slice)
         """
-        return _libBornAgainFit.vector_string_t___delitem__(self, *args)
+        return _libBornAgainFit.vector_string_T___delitem__(self, *args)
 
     def __getitem__(self, *args):
         r"""
-        __getitem__(vector_string_t self, SWIGPY_SLICEOBJECT * slice) -> vector_string_t
-        __getitem__(vector_string_t self, std::vector< std::string >::difference_type i) -> std::vector< std::string >::value_type const &
+        __getitem__(vector_string_T self, SWIGPY_SLICEOBJECT * slice) -> vector_string_T
+        __getitem__(vector_string_T self, std::vector< std::string >::difference_type i) -> std::vector< std::string >::value_type const &
         """
-        return _libBornAgainFit.vector_string_t___getitem__(self, *args)
+        return _libBornAgainFit.vector_string_T___getitem__(self, *args)
 
     def __setitem__(self, *args):
         r"""
-        __setitem__(vector_string_t self, SWIGPY_SLICEOBJECT * slice, vector_string_t v)
-        __setitem__(vector_string_t self, SWIGPY_SLICEOBJECT * slice)
-        __setitem__(vector_string_t self, std::vector< std::string >::difference_type i, std::vector< std::string >::value_type const & x)
+        __setitem__(vector_string_T self, SWIGPY_SLICEOBJECT * slice, vector_string_T v)
+        __setitem__(vector_string_T self, SWIGPY_SLICEOBJECT * slice)
+        __setitem__(vector_string_T self, std::vector< std::string >::difference_type i, std::vector< std::string >::value_type const & x)
         """
-        return _libBornAgainFit.vector_string_t___setitem__(self, *args)
+        return _libBornAgainFit.vector_string_T___setitem__(self, *args)
 
     def pop(self):
-        r"""pop(vector_string_t self) -> std::vector< std::string >::value_type"""
-        return _libBornAgainFit.vector_string_t_pop(self)
+        r"""pop(vector_string_T self) -> std::vector< std::string >::value_type"""
+        return _libBornAgainFit.vector_string_T_pop(self)
 
     def append(self, x):
-        r"""append(vector_string_t self, std::vector< std::string >::value_type const & x)"""
-        return _libBornAgainFit.vector_string_t_append(self, x)
+        r"""append(vector_string_T self, std::vector< std::string >::value_type const & x)"""
+        return _libBornAgainFit.vector_string_T_append(self, x)
 
     def empty(self):
-        r"""empty(vector_string_t self) -> bool"""
-        return _libBornAgainFit.vector_string_t_empty(self)
+        r"""empty(vector_string_T self) -> bool"""
+        return _libBornAgainFit.vector_string_T_empty(self)
 
     def size(self):
-        r"""size(vector_string_t self) -> std::vector< std::string >::size_type"""
-        return _libBornAgainFit.vector_string_t_size(self)
+        r"""size(vector_string_T self) -> std::vector< std::string >::size_type"""
+        return _libBornAgainFit.vector_string_T_size(self)
 
     def swap(self, v):
-        r"""swap(vector_string_t self, vector_string_t v)"""
-        return _libBornAgainFit.vector_string_t_swap(self, v)
+        r"""swap(vector_string_T self, vector_string_T v)"""
+        return _libBornAgainFit.vector_string_T_swap(self, v)
 
     def begin(self):
-        r"""begin(vector_string_t self) -> std::vector< std::string >::iterator"""
-        return _libBornAgainFit.vector_string_t_begin(self)
+        r"""begin(vector_string_T self) -> std::vector< std::string >::iterator"""
+        return _libBornAgainFit.vector_string_T_begin(self)
 
     def end(self):
-        r"""end(vector_string_t self) -> std::vector< std::string >::iterator"""
-        return _libBornAgainFit.vector_string_t_end(self)
+        r"""end(vector_string_T self) -> std::vector< std::string >::iterator"""
+        return _libBornAgainFit.vector_string_T_end(self)
 
     def rbegin(self):
-        r"""rbegin(vector_string_t self) -> std::vector< std::string >::reverse_iterator"""
-        return _libBornAgainFit.vector_string_t_rbegin(self)
+        r"""rbegin(vector_string_T self) -> std::vector< std::string >::reverse_iterator"""
+        return _libBornAgainFit.vector_string_T_rbegin(self)
 
     def rend(self):
-        r"""rend(vector_string_t self) -> std::vector< std::string >::reverse_iterator"""
-        return _libBornAgainFit.vector_string_t_rend(self)
+        r"""rend(vector_string_T self) -> std::vector< std::string >::reverse_iterator"""
+        return _libBornAgainFit.vector_string_T_rend(self)
 
     def clear(self):
-        r"""clear(vector_string_t self)"""
-        return _libBornAgainFit.vector_string_t_clear(self)
+        r"""clear(vector_string_T self)"""
+        return _libBornAgainFit.vector_string_T_clear(self)
 
     def get_allocator(self):
-        r"""get_allocator(vector_string_t self) -> std::vector< std::string >::allocator_type"""
-        return _libBornAgainFit.vector_string_t_get_allocator(self)
+        r"""get_allocator(vector_string_T self) -> std::vector< std::string >::allocator_type"""
+        return _libBornAgainFit.vector_string_T_get_allocator(self)
 
     def pop_back(self):
-        r"""pop_back(vector_string_t self)"""
-        return _libBornAgainFit.vector_string_t_pop_back(self)
+        r"""pop_back(vector_string_T self)"""
+        return _libBornAgainFit.vector_string_T_pop_back(self)
 
     def erase(self, *args):
         r"""
-        erase(vector_string_t self, std::vector< std::string >::iterator pos) -> std::vector< std::string >::iterator
-        erase(vector_string_t self, std::vector< std::string >::iterator first, std::vector< std::string >::iterator last) -> std::vector< std::string >::iterator
+        erase(vector_string_T self, std::vector< std::string >::iterator pos) -> std::vector< std::string >::iterator
+        erase(vector_string_T self, std::vector< std::string >::iterator first, std::vector< std::string >::iterator last) -> std::vector< std::string >::iterator
         """
-        return _libBornAgainFit.vector_string_t_erase(self, *args)
+        return _libBornAgainFit.vector_string_T_erase(self, *args)
 
     def __init__(self, *args):
         r"""
-        __init__(vector_string_t self) -> vector_string_t
-        __init__(vector_string_t self, vector_string_t other) -> vector_string_t
-        __init__(vector_string_t self, std::vector< std::string >::size_type size) -> vector_string_t
-        __init__(vector_string_t self, std::vector< std::string >::size_type size, std::vector< std::string >::value_type const & value) -> vector_string_t
+        __init__(vector_string_T self) -> vector_string_T
+        __init__(vector_string_T self, vector_string_T other) -> vector_string_T
+        __init__(vector_string_T self, std::vector< std::string >::size_type size) -> vector_string_T
+        __init__(vector_string_T self, std::vector< std::string >::size_type size, std::vector< std::string >::value_type const & value) -> vector_string_T
         """
-        _libBornAgainFit.vector_string_t_swiginit(self, _libBornAgainFit.new_vector_string_t(*args))
+        _libBornAgainFit.vector_string_T_swiginit(self, _libBornAgainFit.new_vector_string_T(*args))
 
     def push_back(self, x):
-        r"""push_back(vector_string_t self, std::vector< std::string >::value_type const & x)"""
-        return _libBornAgainFit.vector_string_t_push_back(self, x)
+        r"""push_back(vector_string_T self, std::vector< std::string >::value_type const & x)"""
+        return _libBornAgainFit.vector_string_T_push_back(self, x)
 
     def front(self):
-        r"""front(vector_string_t self) -> std::vector< std::string >::value_type const &"""
-        return _libBornAgainFit.vector_string_t_front(self)
+        r"""front(vector_string_T self) -> std::vector< std::string >::value_type const &"""
+        return _libBornAgainFit.vector_string_T_front(self)
 
     def back(self):
-        r"""back(vector_string_t self) -> std::vector< std::string >::value_type const &"""
-        return _libBornAgainFit.vector_string_t_back(self)
+        r"""back(vector_string_T self) -> std::vector< std::string >::value_type const &"""
+        return _libBornAgainFit.vector_string_T_back(self)
 
     def assign(self, n, x):
-        r"""assign(vector_string_t self, std::vector< std::string >::size_type n, std::vector< std::string >::value_type const & x)"""
-        return _libBornAgainFit.vector_string_t_assign(self, n, x)
+        r"""assign(vector_string_T self, std::vector< std::string >::size_type n, std::vector< std::string >::value_type const & x)"""
+        return _libBornAgainFit.vector_string_T_assign(self, n, x)
 
     def resize(self, *args):
         r"""
-        resize(vector_string_t self, std::vector< std::string >::size_type new_size)
-        resize(vector_string_t self, std::vector< std::string >::size_type new_size, std::vector< std::string >::value_type const & x)
+        resize(vector_string_T self, std::vector< std::string >::size_type new_size)
+        resize(vector_string_T self, std::vector< std::string >::size_type new_size, std::vector< std::string >::value_type const & x)
         """
-        return _libBornAgainFit.vector_string_t_resize(self, *args)
+        return _libBornAgainFit.vector_string_T_resize(self, *args)
 
     def insert(self, *args):
         r"""
-        insert(vector_string_t self, std::vector< std::string >::iterator pos, std::vector< std::string >::value_type const & x) -> std::vector< std::string >::iterator
-        insert(vector_string_t self, std::vector< std::string >::iterator pos, std::vector< std::string >::size_type n, std::vector< std::string >::value_type const & x)
+        insert(vector_string_T self, std::vector< std::string >::iterator pos, std::vector< std::string >::value_type const & x) -> std::vector< std::string >::iterator
+        insert(vector_string_T self, std::vector< std::string >::iterator pos, std::vector< std::string >::size_type n, std::vector< std::string >::value_type const & x)
         """
-        return _libBornAgainFit.vector_string_t_insert(self, *args)
+        return _libBornAgainFit.vector_string_T_insert(self, *args)
 
     def reserve(self, n):
-        r"""reserve(vector_string_t self, std::vector< std::string >::size_type n)"""
-        return _libBornAgainFit.vector_string_t_reserve(self, n)
+        r"""reserve(vector_string_T self, std::vector< std::string >::size_type n)"""
+        return _libBornAgainFit.vector_string_T_reserve(self, n)
 
     def capacity(self):
-        r"""capacity(vector_string_t self) -> std::vector< std::string >::size_type"""
-        return _libBornAgainFit.vector_string_t_capacity(self)
-    __swig_destroy__ = _libBornAgainFit.delete_vector_string_t
+        r"""capacity(vector_string_T self) -> std::vector< std::string >::size_type"""
+        return _libBornAgainFit.vector_string_T_capacity(self)
+    __swig_destroy__ = _libBornAgainFit.delete_vector_string_T
 
-# Register vector_string_t in _libBornAgainFit:
-_libBornAgainFit.vector_string_t_swigregister(vector_string_t)
-class map_string_double_t(object):
+# Register vector_string_T in _libBornAgainFit:
+_libBornAgainFit.vector_string_T_swigregister(vector_string_T)
+class map_string_double_T(object):
     r"""Proxy of C++ std::map< std::string,double > class."""
 
     thisown = property(lambda x: x.this.own(), lambda x, v: x.this.own(v), doc="The membership flag")
     __repr__ = _swig_repr
 
     def iterator(self):
-        r"""iterator(map_string_double_t self) -> SwigPyIterator"""
-        return _libBornAgainFit.map_string_double_t_iterator(self)
+        r"""iterator(map_string_double_T self) -> SwigPyIterator"""
+        return _libBornAgainFit.map_string_double_T_iterator(self)
     def __iter__(self):
         return self.iterator()
 
     def __nonzero__(self):
-        r"""__nonzero__(map_string_double_t self) -> bool"""
-        return _libBornAgainFit.map_string_double_t___nonzero__(self)
+        r"""__nonzero__(map_string_double_T self) -> bool"""
+        return _libBornAgainFit.map_string_double_T___nonzero__(self)
 
     def __bool__(self):
-        r"""__bool__(map_string_double_t self) -> bool"""
-        return _libBornAgainFit.map_string_double_t___bool__(self)
+        r"""__bool__(map_string_double_T self) -> bool"""
+        return _libBornAgainFit.map_string_double_T___bool__(self)
 
     def __len__(self):
-        r"""__len__(map_string_double_t self) -> std::map< std::string,double >::size_type"""
-        return _libBornAgainFit.map_string_double_t___len__(self)
+        r"""__len__(map_string_double_T self) -> std::map< std::string,double >::size_type"""
+        return _libBornAgainFit.map_string_double_T___len__(self)
     def __iter__(self):
         return self.key_iterator()
     def iterkeys(self):
@@ -1348,124 +1348,124 @@ class map_string_double_t(object):
         return self.iterator()
 
     def __getitem__(self, key):
-        r"""__getitem__(map_string_double_t self, std::map< std::string,double >::key_type const & key) -> std::map< std::string,double >::mapped_type const &"""
-        return _libBornAgainFit.map_string_double_t___getitem__(self, key)
+        r"""__getitem__(map_string_double_T self, std::map< std::string,double >::key_type const & key) -> std::map< std::string,double >::mapped_type const &"""
+        return _libBornAgainFit.map_string_double_T___getitem__(self, key)
 
     def __delitem__(self, key):
-        r"""__delitem__(map_string_double_t self, std::map< std::string,double >::key_type const & key)"""
-        return _libBornAgainFit.map_string_double_t___delitem__(self, key)
+        r"""__delitem__(map_string_double_T self, std::map< std::string,double >::key_type const & key)"""
+        return _libBornAgainFit.map_string_double_T___delitem__(self, key)
 
     def has_key(self, key):
-        r"""has_key(map_string_double_t self, std::map< std::string,double >::key_type const & key) -> bool"""
-        return _libBornAgainFit.map_string_double_t_has_key(self, key)
+        r"""has_key(map_string_double_T self, std::map< std::string,double >::key_type const & key) -> bool"""
+        return _libBornAgainFit.map_string_double_T_has_key(self, key)
 
     def keys(self):
-        r"""keys(map_string_double_t self) -> PyObject *"""
-        return _libBornAgainFit.map_string_double_t_keys(self)
+        r"""keys(map_string_double_T self) -> PyObject *"""
+        return _libBornAgainFit.map_string_double_T_keys(self)
 
     def values(self):
-        r"""values(map_string_double_t self) -> PyObject *"""
-        return _libBornAgainFit.map_string_double_t_values(self)
+        r"""values(map_string_double_T self) -> PyObject *"""
+        return _libBornAgainFit.map_string_double_T_values(self)
 
     def items(self):
-        r"""items(map_string_double_t self) -> PyObject *"""
-        return _libBornAgainFit.map_string_double_t_items(self)
+        r"""items(map_string_double_T self) -> PyObject *"""
+        return _libBornAgainFit.map_string_double_T_items(self)
 
     def __contains__(self, key):
-        r"""__contains__(map_string_double_t self, std::map< std::string,double >::key_type const & key) -> bool"""
-        return _libBornAgainFit.map_string_double_t___contains__(self, key)
+        r"""__contains__(map_string_double_T self, std::map< std::string,double >::key_type const & key) -> bool"""
+        return _libBornAgainFit.map_string_double_T___contains__(self, key)
 
     def key_iterator(self):
-        r"""key_iterator(map_string_double_t self) -> SwigPyIterator"""
-        return _libBornAgainFit.map_string_double_t_key_iterator(self)
+        r"""key_iterator(map_string_double_T self) -> SwigPyIterator"""
+        return _libBornAgainFit.map_string_double_T_key_iterator(self)
 
     def value_iterator(self):
-        r"""value_iterator(map_string_double_t self) -> SwigPyIterator"""
-        return _libBornAgainFit.map_string_double_t_value_iterator(self)
+        r"""value_iterator(map_string_double_T self) -> SwigPyIterator"""
+        return _libBornAgainFit.map_string_double_T_value_iterator(self)
 
     def __setitem__(self, *args):
         r"""
-        __setitem__(map_string_double_t self, std::map< std::string,double >::key_type const & key)
-        __setitem__(map_string_double_t self, std::map< std::string,double >::key_type const & key, std::map< std::string,double >::mapped_type const & x)
+        __setitem__(map_string_double_T self, std::map< std::string,double >::key_type const & key)
+        __setitem__(map_string_double_T self, std::map< std::string,double >::key_type const & key, std::map< std::string,double >::mapped_type const & x)
         """
-        return _libBornAgainFit.map_string_double_t___setitem__(self, *args)
+        return _libBornAgainFit.map_string_double_T___setitem__(self, *args)
 
     def asdict(self):
-        r"""asdict(map_string_double_t self) -> PyObject *"""
-        return _libBornAgainFit.map_string_double_t_asdict(self)
+        r"""asdict(map_string_double_T self) -> PyObject *"""
+        return _libBornAgainFit.map_string_double_T_asdict(self)
 
     def __init__(self, *args):
         r"""
-        __init__(map_string_double_t self, std::less< std::string > const & other) -> map_string_double_t
-        __init__(map_string_double_t self) -> map_string_double_t
-        __init__(map_string_double_t self, map_string_double_t other) -> map_string_double_t
+        __init__(map_string_double_T self, std::less< std::string > const & other) -> map_string_double_T
+        __init__(map_string_double_T self) -> map_string_double_T
+        __init__(map_string_double_T self, map_string_double_T other) -> map_string_double_T
         """
-        _libBornAgainFit.map_string_double_t_swiginit(self, _libBornAgainFit.new_map_string_double_t(*args))
+        _libBornAgainFit.map_string_double_T_swiginit(self, _libBornAgainFit.new_map_string_double_T(*args))
 
     def empty(self):
-        r"""empty(map_string_double_t self) -> bool"""
-        return _libBornAgainFit.map_string_double_t_empty(self)
+        r"""empty(map_string_double_T self) -> bool"""
+        return _libBornAgainFit.map_string_double_T_empty(self)
 
     def size(self):
-        r"""size(map_string_double_t self) -> std::map< std::string,double >::size_type"""
-        return _libBornAgainFit.map_string_double_t_size(self)
+        r"""size(map_string_double_T self) -> std::map< std::string,double >::size_type"""
+        return _libBornAgainFit.map_string_double_T_size(self)
 
     def swap(self, v):
-        r"""swap(map_string_double_t self, map_string_double_t v)"""
-        return _libBornAgainFit.map_string_double_t_swap(self, v)
+        r"""swap(map_string_double_T self, map_string_double_T v)"""
+        return _libBornAgainFit.map_string_double_T_swap(self, v)
 
     def begin(self):
-        r"""begin(map_string_double_t self) -> std::map< std::string,double >::iterator"""
-        return _libBornAgainFit.map_string_double_t_begin(self)
+        r"""begin(map_string_double_T self) -> std::map< std::string,double >::iterator"""
+        return _libBornAgainFit.map_string_double_T_begin(self)
 
     def end(self):
-        r"""end(map_string_double_t self) -> std::map< std::string,double >::iterator"""
-        return _libBornAgainFit.map_string_double_t_end(self)
+        r"""end(map_string_double_T self) -> std::map< std::string,double >::iterator"""
+        return _libBornAgainFit.map_string_double_T_end(self)
 
     def rbegin(self):
-        r"""rbegin(map_string_double_t self) -> std::map< std::string,double >::reverse_iterator"""
-        return _libBornAgainFit.map_string_double_t_rbegin(self)
+        r"""rbegin(map_string_double_T self) -> std::map< std::string,double >::reverse_iterator"""
+        return _libBornAgainFit.map_string_double_T_rbegin(self)
 
     def rend(self):
-        r"""rend(map_string_double_t self) -> std::map< std::string,double >::reverse_iterator"""
-        return _libBornAgainFit.map_string_double_t_rend(self)
+        r"""rend(map_string_double_T self) -> std::map< std::string,double >::reverse_iterator"""
+        return _libBornAgainFit.map_string_double_T_rend(self)
 
     def clear(self):
-        r"""clear(map_string_double_t self)"""
-        return _libBornAgainFit.map_string_double_t_clear(self)
+        r"""clear(map_string_double_T self)"""
+        return _libBornAgainFit.map_string_double_T_clear(self)
 
     def get_allocator(self):
-        r"""get_allocator(map_string_double_t self) -> std::map< std::string,double >::allocator_type"""
-        return _libBornAgainFit.map_string_double_t_get_allocator(self)
+        r"""get_allocator(map_string_double_T self) -> std::map< std::string,double >::allocator_type"""
+        return _libBornAgainFit.map_string_double_T_get_allocator(self)
 
     def count(self, x):
-        r"""count(map_string_double_t self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::size_type"""
-        return _libBornAgainFit.map_string_double_t_count(self, x)
+        r"""count(map_string_double_T self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::size_type"""
+        return _libBornAgainFit.map_string_double_T_count(self, x)
 
     def erase(self, *args):
         r"""
-        erase(map_string_double_t self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::size_type
-        erase(map_string_double_t self, std::map< std::string,double >::iterator position)
-        erase(map_string_double_t self, std::map< std::string,double >::iterator first, std::map< std::string,double >::iterator last)
+        erase(map_string_double_T self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::size_type
+        erase(map_string_double_T self, std::map< std::string,double >::iterator position)
+        erase(map_string_double_T self, std::map< std::string,double >::iterator first, std::map< std::string,double >::iterator last)
         """
-        return _libBornAgainFit.map_string_double_t_erase(self, *args)
+        return _libBornAgainFit.map_string_double_T_erase(self, *args)
 
     def find(self, x):
-        r"""find(map_string_double_t self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"""
-        return _libBornAgainFit.map_string_double_t_find(self, x)
+        r"""find(map_string_double_T self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"""
+        return _libBornAgainFit.map_string_double_T_find(self, x)
 
     def lower_bound(self, x):
-        r"""lower_bound(map_string_double_t self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"""
-        return _libBornAgainFit.map_string_double_t_lower_bound(self, x)
+        r"""lower_bound(map_string_double_T self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"""
+        return _libBornAgainFit.map_string_double_T_lower_bound(self, x)
 
     def upper_bound(self, x):
-        r"""upper_bound(map_string_double_t self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"""
-        return _libBornAgainFit.map_string_double_t_upper_bound(self, x)
-    __swig_destroy__ = _libBornAgainFit.delete_map_string_double_t
+        r"""upper_bound(map_string_double_T self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"""
+        return _libBornAgainFit.map_string_double_T_upper_bound(self, x)
+    __swig_destroy__ = _libBornAgainFit.delete_map_string_double_T
 
-# Register map_string_double_t in _libBornAgainFit:
-_libBornAgainFit.map_string_double_t_swigregister(map_string_double_t)
-class pvacuum_double_t(object):
+# Register map_string_double_T in _libBornAgainFit:
+_libBornAgainFit.map_string_double_T_swigregister(map_string_double_T)
+class pvacuum_double_T(object):
     r"""Proxy of C++ std::pair< double,double > class."""
 
     thisown = property(lambda x: x.this.own(), lambda x, v: x.this.own(v), doc="The membership flag")
@@ -1473,13 +1473,13 @@ class pvacuum_double_t(object):
 
     def __init__(self, *args):
         r"""
-        __init__(pvacuum_double_t self) -> pvacuum_double_t
-        __init__(pvacuum_double_t self, double first, double second) -> pvacuum_double_t
-        __init__(pvacuum_double_t self, pvacuum_double_t other) -> pvacuum_double_t
+        __init__(pvacuum_double_T self) -> pvacuum_double_T
+        __init__(pvacuum_double_T self, double first, double second) -> pvacuum_double_T
+        __init__(pvacuum_double_T self, pvacuum_double_T other) -> pvacuum_double_T
         """
-        _libBornAgainFit.pvacuum_double_t_swiginit(self, _libBornAgainFit.new_pvacuum_double_t(*args))
-    first = property(_libBornAgainFit.pvacuum_double_t_first_get, _libBornAgainFit.pvacuum_double_t_first_set, doc=r"""first : double""")
-    second = property(_libBornAgainFit.pvacuum_double_t_second_get, _libBornAgainFit.pvacuum_double_t_second_set, doc=r"""second : double""")
+        _libBornAgainFit.pvacuum_double_T_swiginit(self, _libBornAgainFit.new_pvacuum_double_T(*args))
+    first = property(_libBornAgainFit.pvacuum_double_T_first_get, _libBornAgainFit.pvacuum_double_T_first_set, doc=r"""first : double""")
+    second = property(_libBornAgainFit.pvacuum_double_T_second_get, _libBornAgainFit.pvacuum_double_T_second_set, doc=r"""second : double""")
     def __len__(self):
         return 2
     def __repr__(self):
@@ -1494,176 +1494,176 @@ class pvacuum_double_t(object):
             self.first = val
         else:
             self.second = val
-    __swig_destroy__ = _libBornAgainFit.delete_pvacuum_double_t
+    __swig_destroy__ = _libBornAgainFit.delete_pvacuum_double_T
 
-# Register pvacuum_double_t in _libBornAgainFit:
-_libBornAgainFit.pvacuum_double_t_swigregister(pvacuum_double_t)
-class vector_pvacuum_double_t(object):
+# Register pvacuum_double_T in _libBornAgainFit:
+_libBornAgainFit.pvacuum_double_T_swigregister(pvacuum_double_T)
+class vector_pvacuum_double_T(object):
     r"""Proxy of C++ std::vector< std::pair< double,double > > class."""
 
     thisown = property(lambda x: x.this.own(), lambda x, v: x.this.own(v), doc="The membership flag")
     __repr__ = _swig_repr
 
     def iterator(self):
-        r"""iterator(vector_pvacuum_double_t self) -> SwigPyIterator"""
-        return _libBornAgainFit.vector_pvacuum_double_t_iterator(self)
+        r"""iterator(vector_pvacuum_double_T self) -> SwigPyIterator"""
+        return _libBornAgainFit.vector_pvacuum_double_T_iterator(self)
     def __iter__(self):
         return self.iterator()
 
     def __nonzero__(self):
-        r"""__nonzero__(vector_pvacuum_double_t self) -> bool"""
-        return _libBornAgainFit.vector_pvacuum_double_t___nonzero__(self)
+        r"""__nonzero__(vector_pvacuum_double_T self) -> bool"""
+        return _libBornAgainFit.vector_pvacuum_double_T___nonzero__(self)
 
     def __bool__(self):
-        r"""__bool__(vector_pvacuum_double_t self) -> bool"""
-        return _libBornAgainFit.vector_pvacuum_double_t___bool__(self)
+        r"""__bool__(vector_pvacuum_double_T self) -> bool"""
+        return _libBornAgainFit.vector_pvacuum_double_T___bool__(self)
 
     def __len__(self):
-        r"""__len__(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::size_type"""
-        return _libBornAgainFit.vector_pvacuum_double_t___len__(self)
+        r"""__len__(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::size_type"""
+        return _libBornAgainFit.vector_pvacuum_double_T___len__(self)
 
     def __getslice__(self, i, j):
-        r"""__getslice__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j) -> vector_pvacuum_double_t"""
-        return _libBornAgainFit.vector_pvacuum_double_t___getslice__(self, i, j)
+        r"""__getslice__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j) -> vector_pvacuum_double_T"""
+        return _libBornAgainFit.vector_pvacuum_double_T___getslice__(self, i, j)
 
     def __setslice__(self, *args):
         r"""
-        __setslice__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j)
-        __setslice__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j, vector_pvacuum_double_t v)
+        __setslice__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j)
+        __setslice__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j, vector_pvacuum_double_T v)
         """
-        return _libBornAgainFit.vector_pvacuum_double_t___setslice__(self, *args)
+        return _libBornAgainFit.vector_pvacuum_double_T___setslice__(self, *args)
 
     def __delslice__(self, i, j):
-        r"""__delslice__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j)"""
-        return _libBornAgainFit.vector_pvacuum_double_t___delslice__(self, i, j)
+        r"""__delslice__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j)"""
+        return _libBornAgainFit.vector_pvacuum_double_T___delslice__(self, i, j)
 
     def __delitem__(self, *args):
         r"""
-        __delitem__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i)
-        __delitem__(vector_pvacuum_double_t self, SWIGPY_SLICEOBJECT * slice)
+        __delitem__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i)
+        __delitem__(vector_pvacuum_double_T self, SWIGPY_SLICEOBJECT * slice)
         """
-        return _libBornAgainFit.vector_pvacuum_double_t___delitem__(self, *args)
+        return _libBornAgainFit.vector_pvacuum_double_T___delitem__(self, *args)
 
     def __getitem__(self, *args):
         r"""
-        __getitem__(vector_pvacuum_double_t self, SWIGPY_SLICEOBJECT * slice) -> vector_pvacuum_double_t
-        __getitem__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i) -> pvacuum_double_t
+        __getitem__(vector_pvacuum_double_T self, SWIGPY_SLICEOBJECT * slice) -> vector_pvacuum_double_T
+        __getitem__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i) -> pvacuum_double_T
         """
-        return _libBornAgainFit.vector_pvacuum_double_t___getitem__(self, *args)
+        return _libBornAgainFit.vector_pvacuum_double_T___getitem__(self, *args)
 
     def __setitem__(self, *args):
         r"""
-        __setitem__(vector_pvacuum_double_t self, SWIGPY_SLICEOBJECT * slice, vector_pvacuum_double_t v)
-        __setitem__(vector_pvacuum_double_t self, SWIGPY_SLICEOBJECT * slice)
-        __setitem__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i, pvacuum_double_t x)
+        __setitem__(vector_pvacuum_double_T self, SWIGPY_SLICEOBJECT * slice, vector_pvacuum_double_T v)
+        __setitem__(vector_pvacuum_double_T self, SWIGPY_SLICEOBJECT * slice)
+        __setitem__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i, pvacuum_double_T x)
         """
-        return _libBornAgainFit.vector_pvacuum_double_t___setitem__(self, *args)
+        return _libBornAgainFit.vector_pvacuum_double_T___setitem__(self, *args)
 
     def pop(self):
-        r"""pop(vector_pvacuum_double_t self) -> pvacuum_double_t"""
-        return _libBornAgainFit.vector_pvacuum_double_t_pop(self)
+        r"""pop(vector_pvacuum_double_T self) -> pvacuum_double_T"""
+        return _libBornAgainFit.vector_pvacuum_double_T_pop(self)
 
     def append(self, x):
-        r"""append(vector_pvacuum_double_t self, pvacuum_double_t x)"""
-        return _libBornAgainFit.vector_pvacuum_double_t_append(self, x)
+        r"""append(vector_pvacuum_double_T self, pvacuum_double_T x)"""
+        return _libBornAgainFit.vector_pvacuum_double_T_append(self, x)
 
     def empty(self):
-        r"""empty(vector_pvacuum_double_t self) -> bool"""
-        return _libBornAgainFit.vector_pvacuum_double_t_empty(self)
+        r"""empty(vector_pvacuum_double_T self) -> bool"""
+        return _libBornAgainFit.vector_pvacuum_double_T_empty(self)
 
     def size(self):
-        r"""size(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::size_type"""
-        return _libBornAgainFit.vector_pvacuum_double_t_size(self)
+        r"""size(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::size_type"""
+        return _libBornAgainFit.vector_pvacuum_double_T_size(self)
 
     def swap(self, v):
-        r"""swap(vector_pvacuum_double_t self, vector_pvacuum_double_t v)"""
-        return _libBornAgainFit.vector_pvacuum_double_t_swap(self, v)
+        r"""swap(vector_pvacuum_double_T self, vector_pvacuum_double_T v)"""
+        return _libBornAgainFit.vector_pvacuum_double_T_swap(self, v)
 
     def begin(self):
-        r"""begin(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::iterator"""
-        return _libBornAgainFit.vector_pvacuum_double_t_begin(self)
+        r"""begin(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::iterator"""
+        return _libBornAgainFit.vector_pvacuum_double_T_begin(self)
 
     def end(self):
-        r"""end(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::iterator"""
-        return _libBornAgainFit.vector_pvacuum_double_t_end(self)
+        r"""end(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::iterator"""
+        return _libBornAgainFit.vector_pvacuum_double_T_end(self)
 
     def rbegin(self):
-        r"""rbegin(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::reverse_iterator"""
-        return _libBornAgainFit.vector_pvacuum_double_t_rbegin(self)
+        r"""rbegin(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::reverse_iterator"""
+        return _libBornAgainFit.vector_pvacuum_double_T_rbegin(self)
 
     def rend(self):
-        r"""rend(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::reverse_iterator"""
-        return _libBornAgainFit.vector_pvacuum_double_t_rend(self)
+        r"""rend(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::reverse_iterator"""
+        return _libBornAgainFit.vector_pvacuum_double_T_rend(self)
 
     def clear(self):
-        r"""clear(vector_pvacuum_double_t self)"""
-        return _libBornAgainFit.vector_pvacuum_double_t_clear(self)
+        r"""clear(vector_pvacuum_double_T self)"""
+        return _libBornAgainFit.vector_pvacuum_double_T_clear(self)
 
     def get_allocator(self):
-        r"""get_allocator(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::allocator_type"""
-        return _libBornAgainFit.vector_pvacuum_double_t_get_allocator(self)
+        r"""get_allocator(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::allocator_type"""
+        return _libBornAgainFit.vector_pvacuum_double_T_get_allocator(self)
 
     def pop_back(self):
-        r"""pop_back(vector_pvacuum_double_t self)"""
-        return _libBornAgainFit.vector_pvacuum_double_t_pop_back(self)
+        r"""pop_back(vector_pvacuum_double_T self)"""
+        return _libBornAgainFit.vector_pvacuum_double_T_pop_back(self)
 
     def erase(self, *args):
         r"""
-        erase(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::iterator pos) -> std::vector< std::pair< double,double > >::iterator
-        erase(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::iterator first, std::vector< std::pair< double,double > >::iterator last) -> std::vector< std::pair< double,double > >::iterator
+        erase(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::iterator pos) -> std::vector< std::pair< double,double > >::iterator
+        erase(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::iterator first, std::vector< std::pair< double,double > >::iterator last) -> std::vector< std::pair< double,double > >::iterator
         """
-        return _libBornAgainFit.vector_pvacuum_double_t_erase(self, *args)
+        return _libBornAgainFit.vector_pvacuum_double_T_erase(self, *args)
 
     def __init__(self, *args):
         r"""
-        __init__(vector_pvacuum_double_t self) -> vector_pvacuum_double_t
-        __init__(vector_pvacuum_double_t self, vector_pvacuum_double_t other) -> vector_pvacuum_double_t
-        __init__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::size_type size) -> vector_pvacuum_double_t
-        __init__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::size_type size, pvacuum_double_t value) -> vector_pvacuum_double_t
+        __init__(vector_pvacuum_double_T self) -> vector_pvacuum_double_T
+        __init__(vector_pvacuum_double_T self, vector_pvacuum_double_T other) -> vector_pvacuum_double_T
+        __init__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::size_type size) -> vector_pvacuum_double_T
+        __init__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::size_type size, pvacuum_double_T value) -> vector_pvacuum_double_T
         """
-        _libBornAgainFit.vector_pvacuum_double_t_swiginit(self, _libBornAgainFit.new_vector_pvacuum_double_t(*args))
+        _libBornAgainFit.vector_pvacuum_double_T_swiginit(self, _libBornAgainFit.new_vector_pvacuum_double_T(*args))
 
     def push_back(self, x):
-        r"""push_back(vector_pvacuum_double_t self, pvacuum_double_t x)"""
-        return _libBornAgainFit.vector_pvacuum_double_t_push_back(self, x)
+        r"""push_back(vector_pvacuum_double_T self, pvacuum_double_T x)"""
+        return _libBornAgainFit.vector_pvacuum_double_T_push_back(self, x)
 
     def front(self):
-        r"""front(vector_pvacuum_double_t self) -> pvacuum_double_t"""
-        return _libBornAgainFit.vector_pvacuum_double_t_front(self)
+        r"""front(vector_pvacuum_double_T self) -> pvacuum_double_T"""
+        return _libBornAgainFit.vector_pvacuum_double_T_front(self)
 
     def back(self):
-        r"""back(vector_pvacuum_double_t self) -> pvacuum_double_t"""
-        return _libBornAgainFit.vector_pvacuum_double_t_back(self)
+        r"""back(vector_pvacuum_double_T self) -> pvacuum_double_T"""
+        return _libBornAgainFit.vector_pvacuum_double_T_back(self)
 
     def assign(self, n, x):
-        r"""assign(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::size_type n, pvacuum_double_t x)"""
-        return _libBornAgainFit.vector_pvacuum_double_t_assign(self, n, x)
+        r"""assign(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::size_type n, pvacuum_double_T x)"""
+        return _libBornAgainFit.vector_pvacuum_double_T_assign(self, n, x)
 
     def resize(self, *args):
         r"""
-        resize(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::size_type new_size)
-        resize(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::size_type new_size, pvacuum_double_t x)
+        resize(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::size_type new_size)
+        resize(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::size_type new_size, pvacuum_double_T x)
         """
-        return _libBornAgainFit.vector_pvacuum_double_t_resize(self, *args)
+        return _libBornAgainFit.vector_pvacuum_double_T_resize(self, *args)
 
     def insert(self, *args):
         r"""
-        insert(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::iterator pos, pvacuum_double_t x) -> std::vector< std::pair< double,double > >::iterator
-        insert(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::iterator pos, std::vector< std::pair< double,double > >::size_type n, pvacuum_double_t x)
+        insert(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::iterator pos, pvacuum_double_T x) -> std::vector< std::pair< double,double > >::iterator
+        insert(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::iterator pos, std::vector< std::pair< double,double > >::size_type n, pvacuum_double_T x)
         """
-        return _libBornAgainFit.vector_pvacuum_double_t_insert(self, *args)
+        return _libBornAgainFit.vector_pvacuum_double_T_insert(self, *args)
 
     def reserve(self, n):
-        r"""reserve(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::size_type n)"""
-        return _libBornAgainFit.vector_pvacuum_double_t_reserve(self, n)
+        r"""reserve(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::size_type n)"""
+        return _libBornAgainFit.vector_pvacuum_double_T_reserve(self, n)
 
     def capacity(self):
-        r"""capacity(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::size_type"""
-        return _libBornAgainFit.vector_pvacuum_double_t_capacity(self)
-    __swig_destroy__ = _libBornAgainFit.delete_vector_pvacuum_double_t
+        r"""capacity(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::size_type"""
+        return _libBornAgainFit.vector_pvacuum_double_T_capacity(self)
+    __swig_destroy__ = _libBornAgainFit.delete_vector_pvacuum_double_T
 
-# Register vector_pvacuum_double_t in _libBornAgainFit:
-_libBornAgainFit.vector_pvacuum_double_t_swigregister(vector_pvacuum_double_t)
+# Register vector_pvacuum_double_T in _libBornAgainFit:
+_libBornAgainFit.vector_pvacuum_double_T_swigregister(vector_pvacuum_double_T)
 class RealLimits(object):
     r"""Proxy of C++ RealLimits class."""
 
@@ -1940,27 +1940,27 @@ class Parameters(object):
         return _libBornAgainFit.Parameters_size(self)
 
     def values(self):
-        r"""values(Parameters self) -> vdouble1d_t"""
+        r"""values(Parameters self) -> vdouble1d_T"""
         return _libBornAgainFit.Parameters_values(self)
 
     def setValues(self, values):
-        r"""setValues(Parameters self, vdouble1d_t values)"""
+        r"""setValues(Parameters self, vdouble1d_T values)"""
         return _libBornAgainFit.Parameters_setValues(self, values)
 
     def errors(self):
-        r"""errors(Parameters self) -> vdouble1d_t"""
+        r"""errors(Parameters self) -> vdouble1d_T"""
         return _libBornAgainFit.Parameters_errors(self)
 
     def setErrors(self, errors):
-        r"""setErrors(Parameters self, vdouble1d_t errors)"""
+        r"""setErrors(Parameters self, vdouble1d_T errors)"""
         return _libBornAgainFit.Parameters_setErrors(self, errors)
 
     def correlationMatrix(self):
-        r"""correlationMatrix(Parameters self) -> vdouble2d_t"""
+        r"""correlationMatrix(Parameters self) -> double2d_t"""
         return _libBornAgainFit.Parameters_correlationMatrix(self)
 
     def setCorrelationMatrix(self, matrix):
-        r"""setCorrelationMatrix(Parameters self, vdouble2d_t matrix)"""
+        r"""setCorrelationMatrix(Parameters self, double2d_t const & matrix)"""
         return _libBornAgainFit.Parameters_setCorrelationMatrix(self, matrix)
 
     def freeParameterCount(self):
@@ -2160,12 +2160,12 @@ class MinimizerFactory(object):
 
     @staticmethod
     def algorithmNames(minimizerName):
-        r"""algorithmNames(std::string const & minimizerName) -> vector_string_t"""
+        r"""algorithmNames(std::string const & minimizerName) -> vector_string_T"""
         return _libBornAgainFit.MinimizerFactory_algorithmNames(minimizerName)
 
     @staticmethod
     def algorithmDescriptions(minimizerName):
-        r"""algorithmDescriptions(std::string const & minimizerName) -> vector_string_t"""
+        r"""algorithmDescriptions(std::string const & minimizerName) -> vector_string_T"""
         return _libBornAgainFit.MinimizerFactory_algorithmDescriptions(minimizerName)
 
     def __init__(self):
@@ -2203,7 +2203,7 @@ class PyCallback(object):
         return _libBornAgainFit.PyCallback_call_scalar(self, pars)
 
     def call_residuals(self, pars):
-        r"""call_residuals(PyCallback self, Parameters pars) -> vdouble1d_t"""
+        r"""call_residuals(PyCallback self, Parameters pars) -> vdouble1d_T"""
         return _libBornAgainFit.PyCallback_call_residuals(self, pars)
     def __disown__(self):
         self.this.disown()
diff --git a/auto/Wrap/libBornAgainFit_wrap.cpp b/auto/Wrap/libBornAgainFit_wrap.cpp
index 4fdf8885d54c5619ed6bbd53ccadfb43af127436..de7b564e88ece593caa0eaa27557b1e7dd058035 100644
--- a/auto/Wrap/libBornAgainFit_wrap.cpp
+++ b/auto/Wrap/libBornAgainFit_wrap.cpp
@@ -3653,8 +3653,8 @@ namespace Swig {
 #define SWIGTYPE_p_allocator_type swig_types[5]
 #define SWIGTYPE_p_char swig_types[6]
 #define SWIGTYPE_p_const_iterator swig_types[7]
-#define SWIGTYPE_p_corr_matrix_t swig_types[8]
-#define SWIGTYPE_p_difference_type swig_types[9]
+#define SWIGTYPE_p_difference_type swig_types[8]
+#define SWIGTYPE_p_double2d_t swig_types[9]
 #define SWIGTYPE_p_fcn_residual_t swig_types[10]
 #define SWIGTYPE_p_fcn_scalar_t swig_types[11]
 #define SWIGTYPE_p_first_type swig_types[12]
@@ -7959,7 +7959,7 @@ SWIGINTERN PyObject *SwigPyIterator_swigregister(PyObject *SWIGUNUSEDPARM(self),
   return SWIG_Py_Void();
 }
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_iterator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_iterator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   PyObject **arg2 = (PyObject **) 0 ;
@@ -7974,7 +7974,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_iterator(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_iterator" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_iterator" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = (swig::SwigPyIterator *)std_vector_Sl_double_Sg__iterator(arg1,arg2);
@@ -7985,7 +7985,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___nonzero__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___nonzero__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -7998,7 +7998,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___nonzero__(PyObject *self, PyObject *arg
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___nonzero__" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___nonzero__" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = (bool)std_vector_Sl_double_Sg____nonzero__((std::vector< double > const *)arg1);
@@ -8009,7 +8009,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___bool__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___bool__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -8022,7 +8022,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___bool__(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___bool__" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___bool__" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = (bool)std_vector_Sl_double_Sg____bool__((std::vector< double > const *)arg1);
@@ -8033,7 +8033,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___len__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___len__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -8046,7 +8046,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___len__(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___len__" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___len__" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = std_vector_Sl_double_Sg____len__((std::vector< double > const *)arg1);
@@ -8057,7 +8057,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___getslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___getslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::difference_type arg2 ;
@@ -8072,20 +8072,20 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___getslice__(PyObject *self, PyObject *ar
   std::vector< double,std::allocator< double > > *result = 0 ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_t___getslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_T___getslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___getslice__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___getslice__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t___getslice__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T___getslice__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< double >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_t___getslice__" "', argument " "3"" of type '" "std::vector< double >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_T___getslice__" "', argument " "3"" of type '" "std::vector< double >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< double >::difference_type >(val3);
   try {
@@ -8102,7 +8102,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::difference_type arg2 ;
@@ -8118,17 +8118,17 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setslice____SWIG_0(PyObject *self, Py_s
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___setslice__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___setslice__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t___setslice__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T___setslice__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< double >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_t___setslice__" "', argument " "3"" of type '" "std::vector< double >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_T___setslice__" "', argument " "3"" of type '" "std::vector< double >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< double >::difference_type >(val3);
   try {
@@ -8145,7 +8145,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::difference_type arg2 ;
@@ -8163,27 +8163,27 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setslice____SWIG_1(PyObject *self, Py_s
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___setslice__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___setslice__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t___setslice__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T___setslice__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< double >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_t___setslice__" "', argument " "3"" of type '" "std::vector< double >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_T___setslice__" "', argument " "3"" of type '" "std::vector< double >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< double >::difference_type >(val3);
   {
     std::vector< double,std::allocator< double > > *ptr = (std::vector< double,std::allocator< double > > *)0;
     res4 = swig::asptr(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vdouble1d_t___setslice__" "', argument " "4"" of type '" "std::vector< double,std::allocator< double > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vdouble1d_T___setslice__" "', argument " "4"" of type '" "std::vector< double,std::allocator< double > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble1d_t___setslice__" "', argument " "4"" of type '" "std::vector< double,std::allocator< double > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble1d_T___setslice__" "', argument " "4"" of type '" "std::vector< double,std::allocator< double > > const &""'"); 
     }
     arg4 = ptr;
   }
@@ -8203,13 +8203,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___setslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___setslice__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_t___setslice__", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_T___setslice__", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -8226,7 +8226,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setslice__(PyObject *self, PyObject *ar
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vdouble1d_t___setslice____SWIG_0(self, argc, argv);
+          return _wrap_vdouble1d_T___setslice____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -8249,7 +8249,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setslice__(PyObject *self, PyObject *ar
           int res = swig::asptr(argv[3], (std::vector< double,std::allocator< double > >**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vdouble1d_t___setslice____SWIG_1(self, argc, argv);
+            return _wrap_vdouble1d_T___setslice____SWIG_1(self, argc, argv);
           }
         }
       }
@@ -8257,7 +8257,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setslice__(PyObject *self, PyObject *ar
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_t___setslice__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_T___setslice__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< double >::__setslice__(std::vector< double >::difference_type,std::vector< double >::difference_type)\n"
     "    std::vector< double >::__setslice__(std::vector< double >::difference_type,std::vector< double >::difference_type,std::vector< double,std::allocator< double > > const &)\n");
@@ -8265,7 +8265,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___delslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___delslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::difference_type arg2 ;
@@ -8279,20 +8279,20 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___delslice__(PyObject *self, PyObject *ar
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_t___delslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_T___delslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___delslice__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___delslice__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t___delslice__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T___delslice__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< double >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_t___delslice__" "', argument " "3"" of type '" "std::vector< double >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_T___delslice__" "', argument " "3"" of type '" "std::vector< double >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< double >::difference_type >(val3);
   try {
@@ -8309,7 +8309,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::difference_type arg2 ;
@@ -8322,12 +8322,12 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___delitem____SWIG_0(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___delitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___delitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t___delitem__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T___delitem__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< double >::difference_type >(val2);
   try {
@@ -8344,7 +8344,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -8356,12 +8356,12 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___getitem____SWIG_0(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___getitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___getitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -8379,7 +8379,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -8392,12 +8392,12 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setitem____SWIG_0(PyObject *self, Py_ss
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___setitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___setitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -8405,10 +8405,10 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setitem____SWIG_0(PyObject *self, Py_ss
     std::vector< double,std::allocator< double > > *ptr = (std::vector< double,std::allocator< double > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble1d_t___setitem__" "', argument " "3"" of type '" "std::vector< double,std::allocator< double > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble1d_T___setitem__" "', argument " "3"" of type '" "std::vector< double,std::allocator< double > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble1d_t___setitem__" "', argument " "3"" of type '" "std::vector< double,std::allocator< double > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble1d_T___setitem__" "', argument " "3"" of type '" "std::vector< double,std::allocator< double > > const &""'"); 
     }
     arg3 = ptr;
   }
@@ -8428,7 +8428,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -8439,12 +8439,12 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setitem____SWIG_1(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___setitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___setitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -8462,7 +8462,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -8473,12 +8473,12 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___delitem____SWIG_1(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___delitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___delitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -8496,13 +8496,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___delitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___delitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_t___delitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_T___delitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -8513,7 +8513,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___delitem__(PyObject *self, PyObject *arg
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vdouble1d_t___delitem____SWIG_1(self, argc, argv);
+        return _wrap_vdouble1d_T___delitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -8527,13 +8527,13 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___delitem__(PyObject *self, PyObject *arg
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vdouble1d_t___delitem____SWIG_0(self, argc, argv);
+        return _wrap_vdouble1d_T___delitem____SWIG_0(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_t___delitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_T___delitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< double >::__delitem__(std::vector< double >::difference_type)\n"
     "    std::vector< double >::__delitem__(SWIGPY_SLICEOBJECT *)\n");
@@ -8541,7 +8541,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::difference_type arg2 ;
@@ -8555,12 +8555,12 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___getitem____SWIG_1(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___getitem__" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___getitem__" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t___getitem__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T___getitem__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< double >::difference_type >(val2);
   try {
@@ -8576,13 +8576,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___getitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___getitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_t___getitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_T___getitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -8593,7 +8593,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___getitem__(PyObject *self, PyObject *arg
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vdouble1d_t___getitem____SWIG_0(self, argc, argv);
+        return _wrap_vdouble1d_T___getitem____SWIG_0(self, argc, argv);
       }
     }
   }
@@ -8607,13 +8607,13 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___getitem__(PyObject *self, PyObject *arg
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vdouble1d_t___getitem____SWIG_1(self, argc, argv);
+        return _wrap_vdouble1d_T___getitem____SWIG_1(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_t___getitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_T___getitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< double >::__getitem__(SWIGPY_SLICEOBJECT *)\n"
     "    std::vector< double >::__getitem__(std::vector< double >::difference_type) const\n");
@@ -8621,7 +8621,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::difference_type arg2 ;
@@ -8638,17 +8638,17 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setitem____SWIG_2(PyObject *self, Py_ss
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___setitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___setitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t___setitem__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T___setitem__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< double >::difference_type >(val2);
   ecode3 = SWIG_AsVal_double(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_t___setitem__" "', argument " "3"" of type '" "std::vector< double >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_T___setitem__" "', argument " "3"" of type '" "std::vector< double >::value_type""'");
   } 
   temp3 = static_cast< std::vector< double >::value_type >(val3);
   arg3 = &temp3;
@@ -8664,13 +8664,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___setitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___setitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_t___setitem__", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_T___setitem__", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -8681,7 +8681,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setitem__(PyObject *self, PyObject *arg
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vdouble1d_t___setitem____SWIG_1(self, argc, argv);
+        return _wrap_vdouble1d_T___setitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -8697,7 +8697,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setitem__(PyObject *self, PyObject *arg
         int res = swig::asptr(argv[2], (std::vector< double,std::allocator< double > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vdouble1d_t___setitem____SWIG_0(self, argc, argv);
+          return _wrap_vdouble1d_T___setitem____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -8717,14 +8717,14 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setitem__(PyObject *self, PyObject *arg
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vdouble1d_t___setitem____SWIG_2(self, argc, argv);
+          return _wrap_vdouble1d_T___setitem____SWIG_2(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_t___setitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_T___setitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< double >::__setitem__(SWIGPY_SLICEOBJECT *,std::vector< double,std::allocator< double > > const &)\n"
     "    std::vector< double >::__setitem__(SWIGPY_SLICEOBJECT *)\n"
@@ -8733,7 +8733,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_pop(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_pop(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -8746,7 +8746,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_pop(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_pop" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_pop" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   try {
@@ -8761,7 +8761,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_append(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_append(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::value_type *arg2 = 0 ;
@@ -8773,15 +8773,15 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_append(PyObject *self, PyObject *args) {
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_t_append", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_T_append", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_append" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_append" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_double(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t_append" "', argument " "2"" of type '" "std::vector< double >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T_append" "', argument " "2"" of type '" "std::vector< double >::value_type""'");
   } 
   temp2 = static_cast< std::vector< double >::value_type >(val2);
   arg2 = &temp2;
@@ -8793,7 +8793,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vdouble1d_t__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
+SWIGINTERN PyObject *_wrap_new_vdouble1d_T__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
   PyObject *resultobj = 0;
   std::vector< double > *result = 0 ;
   
@@ -8807,7 +8807,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vdouble1d_t__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vdouble1d_T__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = 0 ;
   int res1 = SWIG_OLDOBJ ;
@@ -8819,10 +8819,10 @@ SWIGINTERN PyObject *_wrap_new_vdouble1d_t__SWIG_1(PyObject *self, Py_ssize_t no
     std::vector< double,std::allocator< double > > *ptr = (std::vector< double,std::allocator< double > > *)0;
     res1 = swig::asptr(swig_obj[0], &ptr);
     if (!SWIG_IsOK(res1)) {
-      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vdouble1d_t" "', argument " "1"" of type '" "std::vector< double > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vdouble1d_T" "', argument " "1"" of type '" "std::vector< double > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vdouble1d_t" "', argument " "1"" of type '" "std::vector< double > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vdouble1d_T" "', argument " "1"" of type '" "std::vector< double > const &""'"); 
     }
     arg1 = ptr;
   }
@@ -8836,7 +8836,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_empty(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_empty(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -8849,7 +8849,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_empty(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_empty" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_empty" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = (bool)((std::vector< double > const *)arg1)->empty();
@@ -8860,7 +8860,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_size(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_size(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -8873,7 +8873,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_size(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_size" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_size" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = ((std::vector< double > const *)arg1)->size();
@@ -8884,7 +8884,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_swap(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_swap(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double > *arg2 = 0 ;
@@ -8895,18 +8895,18 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_swap(PyObject *self, PyObject *args) {
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_t_swap", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_T_swap", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_swap" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_swap" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], &argp2, SWIGTYPE_p_std__vectorT_double_t,  0 );
   if (!SWIG_IsOK(res2)) {
-    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vdouble1d_t_swap" "', argument " "2"" of type '" "std::vector< double > &""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vdouble1d_T_swap" "', argument " "2"" of type '" "std::vector< double > &""'"); 
   }
   if (!argp2) {
-    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble1d_t_swap" "', argument " "2"" of type '" "std::vector< double > &""'"); 
+    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble1d_T_swap" "', argument " "2"" of type '" "std::vector< double > &""'"); 
   }
   arg2 = reinterpret_cast< std::vector< double > * >(argp2);
   (arg1)->swap(*arg2);
@@ -8917,7 +8917,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_begin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_begin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -8930,7 +8930,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_begin(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_begin" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_begin" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = (arg1)->begin();
@@ -8942,7 +8942,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_end(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_end(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -8955,7 +8955,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_end(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_end" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_end" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = (arg1)->end();
@@ -8967,7 +8967,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_rbegin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_rbegin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -8980,7 +8980,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_rbegin(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_rbegin" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_rbegin" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = (arg1)->rbegin();
@@ -8992,7 +8992,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_rend(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_rend(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -9005,7 +9005,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_rend(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_rend" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_rend" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = (arg1)->rend();
@@ -9017,7 +9017,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_clear(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_clear(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -9029,7 +9029,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_clear(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_clear" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_clear" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   (arg1)->clear();
@@ -9040,7 +9040,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_get_allocator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_get_allocator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -9053,7 +9053,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_get_allocator(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_get_allocator" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_get_allocator" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = ((std::vector< double > const *)arg1)->get_allocator();
@@ -9064,7 +9064,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vdouble1d_t__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vdouble1d_T__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double >::size_type arg1 ;
   size_t val1 ;
@@ -9075,7 +9075,7 @@ SWIGINTERN PyObject *_wrap_new_vdouble1d_t__SWIG_2(PyObject *self, Py_ssize_t no
   if ((nobjs < 1) || (nobjs > 1)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vdouble1d_t" "', argument " "1"" of type '" "std::vector< double >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vdouble1d_T" "', argument " "1"" of type '" "std::vector< double >::size_type""'");
   } 
   arg1 = static_cast< std::vector< double >::size_type >(val1);
   result = (std::vector< double > *)new std::vector< double >(arg1);
@@ -9086,7 +9086,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_pop_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_pop_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -9098,7 +9098,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_pop_back(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_pop_back" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_pop_back" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   (arg1)->pop_back();
@@ -9109,7 +9109,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::size_type arg2 ;
@@ -9122,12 +9122,12 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_resize__SWIG_0(PyObject *self, Py_ssize_t
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_resize" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_resize" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t_resize" "', argument " "2"" of type '" "std::vector< double >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T_resize" "', argument " "2"" of type '" "std::vector< double >::size_type""'");
   } 
   arg2 = static_cast< std::vector< double >::size_type >(val2);
   (arg1)->resize(arg2);
@@ -9138,7 +9138,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::iterator arg2 ;
@@ -9152,18 +9152,18 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_erase__SWIG_0(PyObject *self, Py_ssize_t
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_erase" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_erase" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t_erase" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T_erase" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< double >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< double >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t_erase" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T_erase" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
     }
   }
   result = std_vector_Sl_double_Sg__erase__SWIG_0(arg1,SWIG_STD_MOVE(arg2));
@@ -9175,7 +9175,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::iterator arg2 ;
@@ -9192,29 +9192,29 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_erase__SWIG_1(PyObject *self, Py_ssize_t
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_erase" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_erase" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t_erase" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T_erase" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< double >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< double >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t_erase" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T_erase" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
     }
   }
   res3 = SWIG_ConvertPtr(swig_obj[2], SWIG_as_voidptrptr(&iter3), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res3) || !iter3) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t_erase" "', argument " "3"" of type '" "std::vector< double >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T_erase" "', argument " "3"" of type '" "std::vector< double >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< double >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< double >::iterator > *>(iter3);
     if (iter_t) {
       arg3 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t_erase" "', argument " "3"" of type '" "std::vector< double >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T_erase" "', argument " "3"" of type '" "std::vector< double >::iterator""'");
     }
   }
   result = std_vector_Sl_double_Sg__erase__SWIG_1(arg1,SWIG_STD_MOVE(arg2),SWIG_STD_MOVE(arg3));
@@ -9226,13 +9226,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_erase(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_erase(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_t_erase", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_T_erase", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -9243,7 +9243,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_erase(PyObject *self, PyObject *args) {
       int res = SWIG_ConvertPtr(argv[1], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
       _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< double >::iterator > *>(iter) != 0));
       if (_v) {
-        return _wrap_vdouble1d_t_erase__SWIG_0(self, argc, argv);
+        return _wrap_vdouble1d_T_erase__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -9260,14 +9260,14 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_erase(PyObject *self, PyObject *args) {
         int res = SWIG_ConvertPtr(argv[2], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
         _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< double >::iterator > *>(iter) != 0));
         if (_v) {
-          return _wrap_vdouble1d_t_erase__SWIG_1(self, argc, argv);
+          return _wrap_vdouble1d_T_erase__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_t_erase'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_T_erase'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< double >::erase(std::vector< double >::iterator)\n"
     "    std::vector< double >::erase(std::vector< double >::iterator,std::vector< double >::iterator)\n");
@@ -9275,7 +9275,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vdouble1d_t__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vdouble1d_T__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double >::size_type arg1 ;
   std::vector< double >::value_type *arg2 = 0 ;
@@ -9290,12 +9290,12 @@ SWIGINTERN PyObject *_wrap_new_vdouble1d_t__SWIG_3(PyObject *self, Py_ssize_t no
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vdouble1d_t" "', argument " "1"" of type '" "std::vector< double >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vdouble1d_T" "', argument " "1"" of type '" "std::vector< double >::size_type""'");
   } 
   arg1 = static_cast< std::vector< double >::size_type >(val1);
   ecode2 = SWIG_AsVal_double(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "new_vdouble1d_t" "', argument " "2"" of type '" "std::vector< double >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "new_vdouble1d_T" "', argument " "2"" of type '" "std::vector< double >::value_type""'");
   } 
   temp2 = static_cast< std::vector< double >::value_type >(val2);
   arg2 = &temp2;
@@ -9307,16 +9307,16 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vdouble1d_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_new_vdouble1d_T(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vdouble1d_t", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vdouble1d_T", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 0) {
-    return _wrap_new_vdouble1d_t__SWIG_0(self, argc, argv);
+    return _wrap_new_vdouble1d_T__SWIG_0(self, argc, argv);
   }
   if (argc == 1) {
     int _v = 0;
@@ -9325,7 +9325,7 @@ SWIGINTERN PyObject *_wrap_new_vdouble1d_t(PyObject *self, PyObject *args) {
       _v = SWIG_CheckState(res);
     }
     if (_v) {
-      return _wrap_new_vdouble1d_t__SWIG_2(self, argc, argv);
+      return _wrap_new_vdouble1d_T__SWIG_2(self, argc, argv);
     }
   }
   if (argc == 1) {
@@ -9333,7 +9333,7 @@ SWIGINTERN PyObject *_wrap_new_vdouble1d_t(PyObject *self, PyObject *args) {
     int res = swig::asptr(argv[0], (std::vector< double,std::allocator< double > >**)(0));
     _v = SWIG_CheckState(res);
     if (_v) {
-      return _wrap_new_vdouble1d_t__SWIG_1(self, argc, argv);
+      return _wrap_new_vdouble1d_T__SWIG_1(self, argc, argv);
     }
   }
   if (argc == 2) {
@@ -9348,13 +9348,13 @@ SWIGINTERN PyObject *_wrap_new_vdouble1d_t(PyObject *self, PyObject *args) {
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_new_vdouble1d_t__SWIG_3(self, argc, argv);
+        return _wrap_new_vdouble1d_T__SWIG_3(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vdouble1d_t'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vdouble1d_T'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< double >::vector()\n"
     "    std::vector< double >::vector(std::vector< double > const &)\n"
@@ -9364,7 +9364,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_push_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_push_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::value_type *arg2 = 0 ;
@@ -9376,15 +9376,15 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_push_back(PyObject *self, PyObject *args)
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_t_push_back", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_T_push_back", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_push_back" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_push_back" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_double(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t_push_back" "', argument " "2"" of type '" "std::vector< double >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T_push_back" "', argument " "2"" of type '" "std::vector< double >::value_type""'");
   } 
   temp2 = static_cast< std::vector< double >::value_type >(val2);
   arg2 = &temp2;
@@ -9396,7 +9396,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_front(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_front(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -9409,7 +9409,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_front(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_front" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_front" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = (std::vector< double >::value_type *) &((std::vector< double > const *)arg1)->front();
@@ -9421,7 +9421,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -9434,7 +9434,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_back(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_back" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_back" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = (std::vector< double >::value_type *) &((std::vector< double > const *)arg1)->back();
@@ -9446,7 +9446,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_assign(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_assign(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::size_type arg2 ;
@@ -9461,20 +9461,20 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_assign(PyObject *self, PyObject *args) {
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_t_assign", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_T_assign", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_assign" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_assign" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t_assign" "', argument " "2"" of type '" "std::vector< double >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T_assign" "', argument " "2"" of type '" "std::vector< double >::size_type""'");
   } 
   arg2 = static_cast< std::vector< double >::size_type >(val2);
   ecode3 = SWIG_AsVal_double(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_t_assign" "', argument " "3"" of type '" "std::vector< double >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_T_assign" "', argument " "3"" of type '" "std::vector< double >::value_type""'");
   } 
   temp3 = static_cast< std::vector< double >::value_type >(val3);
   arg3 = &temp3;
@@ -9486,7 +9486,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::size_type arg2 ;
@@ -9503,17 +9503,17 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_resize__SWIG_1(PyObject *self, Py_ssize_t
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_resize" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_resize" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t_resize" "', argument " "2"" of type '" "std::vector< double >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T_resize" "', argument " "2"" of type '" "std::vector< double >::size_type""'");
   } 
   arg2 = static_cast< std::vector< double >::size_type >(val2);
   ecode3 = SWIG_AsVal_double(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_t_resize" "', argument " "3"" of type '" "std::vector< double >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_T_resize" "', argument " "3"" of type '" "std::vector< double >::value_type""'");
   } 
   temp3 = static_cast< std::vector< double >::value_type >(val3);
   arg3 = &temp3;
@@ -9525,13 +9525,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_resize(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_resize(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_t_resize", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_T_resize", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -9543,7 +9543,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_resize(PyObject *self, PyObject *args) {
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vdouble1d_t_resize__SWIG_0(self, argc, argv);
+        return _wrap_vdouble1d_T_resize__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -9562,14 +9562,14 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_resize(PyObject *self, PyObject *args) {
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vdouble1d_t_resize__SWIG_1(self, argc, argv);
+          return _wrap_vdouble1d_T_resize__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_t_resize'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_T_resize'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< double >::resize(std::vector< double >::size_type)\n"
     "    std::vector< double >::resize(std::vector< double >::size_type,std::vector< double >::value_type const &)\n");
@@ -9577,7 +9577,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::iterator arg2 ;
@@ -9595,23 +9595,23 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_insert__SWIG_0(PyObject *self, Py_ssize_t
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_insert" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_insert" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t_insert" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T_insert" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< double >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< double >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t_insert" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T_insert" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_double(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_t_insert" "', argument " "3"" of type '" "std::vector< double >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_T_insert" "', argument " "3"" of type '" "std::vector< double >::value_type""'");
   } 
   temp3 = static_cast< std::vector< double >::value_type >(val3);
   arg3 = &temp3;
@@ -9624,7 +9624,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::iterator arg2 ;
@@ -9644,28 +9644,28 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_insert__SWIG_1(PyObject *self, Py_ssize_t
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_insert" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_insert" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t_insert" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T_insert" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< double >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< double >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t_insert" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T_insert" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_size_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_t_insert" "', argument " "3"" of type '" "std::vector< double >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_T_insert" "', argument " "3"" of type '" "std::vector< double >::size_type""'");
   } 
   arg3 = static_cast< std::vector< double >::size_type >(val3);
   ecode4 = SWIG_AsVal_double(swig_obj[3], &val4);
   if (!SWIG_IsOK(ecode4)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode4), "in method '" "vdouble1d_t_insert" "', argument " "4"" of type '" "std::vector< double >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode4), "in method '" "vdouble1d_T_insert" "', argument " "4"" of type '" "std::vector< double >::value_type""'");
   } 
   temp4 = static_cast< std::vector< double >::value_type >(val4);
   arg4 = &temp4;
@@ -9677,13 +9677,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_insert(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_insert(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_t_insert", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_T_insert", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -9699,7 +9699,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_insert(PyObject *self, PyObject *args) {
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vdouble1d_t_insert__SWIG_0(self, argc, argv);
+          return _wrap_vdouble1d_T_insert__SWIG_0(self, argc, argv);
         }
       }
     }
@@ -9723,7 +9723,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_insert(PyObject *self, PyObject *args) {
             _v = SWIG_CheckState(res);
           }
           if (_v) {
-            return _wrap_vdouble1d_t_insert__SWIG_1(self, argc, argv);
+            return _wrap_vdouble1d_T_insert__SWIG_1(self, argc, argv);
           }
         }
       }
@@ -9731,7 +9731,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_insert(PyObject *self, PyObject *args) {
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_t_insert'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_T_insert'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< double >::insert(std::vector< double >::iterator,std::vector< double >::value_type const &)\n"
     "    std::vector< double >::insert(std::vector< double >::iterator,std::vector< double >::size_type,std::vector< double >::value_type const &)\n");
@@ -9739,7 +9739,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_reserve(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_reserve(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::size_type arg2 ;
@@ -9750,15 +9750,15 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_reserve(PyObject *self, PyObject *args) {
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_t_reserve", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_T_reserve", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_reserve" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_reserve" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t_reserve" "', argument " "2"" of type '" "std::vector< double >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T_reserve" "', argument " "2"" of type '" "std::vector< double >::size_type""'");
   } 
   arg2 = static_cast< std::vector< double >::size_type >(val2);
   (arg1)->reserve(arg2);
@@ -9769,7 +9769,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_capacity(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_capacity(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -9782,7 +9782,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_capacity(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_capacity" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_capacity" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = ((std::vector< double > const *)arg1)->capacity();
@@ -9793,7 +9793,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_delete_vdouble1d_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_delete_vdouble1d_T(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -9805,7 +9805,7 @@ SWIGINTERN PyObject *_wrap_delete_vdouble1d_t(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, SWIG_POINTER_DISOWN |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vdouble1d_t" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vdouble1d_T" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   {
@@ -9826,18 +9826,18 @@ fail:
 }
 
 
-SWIGINTERN PyObject *vdouble1d_t_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vdouble1d_T_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   PyObject *obj;
   if (!SWIG_Python_UnpackTuple(args, "swigregister", 1, 1, &obj)) return NULL;
   SWIG_TypeNewClientData(SWIGTYPE_p_std__vectorT_double_t, SWIG_NewClientData(obj));
   return SWIG_Py_Void();
 }
 
-SWIGINTERN PyObject *vdouble1d_t_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vdouble1d_T_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   return SWIG_Python_InitShadowInstance(args);
 }
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_iterator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_iterator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   PyObject **arg2 = (PyObject **) 0 ;
@@ -9852,7 +9852,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_iterator(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_iterator" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_iterator" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = (swig::SwigPyIterator *)std_vector_Sl_std_vector_Sl_double_Sg__Sg__iterator(arg1,arg2);
@@ -9863,7 +9863,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___nonzero__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___nonzero__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -9876,7 +9876,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___nonzero__(PyObject *self, PyObject *arg
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___nonzero__" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___nonzero__" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = (bool)std_vector_Sl_std_vector_Sl_double_Sg__Sg____nonzero__((std::vector< std::vector< double > > const *)arg1);
@@ -9887,7 +9887,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___bool__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___bool__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -9900,7 +9900,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___bool__(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___bool__" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___bool__" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = (bool)std_vector_Sl_std_vector_Sl_double_Sg__Sg____bool__((std::vector< std::vector< double > > const *)arg1);
@@ -9911,7 +9911,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___len__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___len__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -9924,7 +9924,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___len__(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___len__" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___len__" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = std_vector_Sl_std_vector_Sl_double_Sg__Sg____len__((std::vector< std::vector< double > > const *)arg1);
@@ -9935,7 +9935,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___getslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___getslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::difference_type arg2 ;
@@ -9950,20 +9950,20 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___getslice__(PyObject *self, PyObject *ar
   std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > *result = 0 ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_t___getslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_T___getslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___getslice__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___getslice__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_t___getslice__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_T___getslice__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble2d_t___getslice__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble2d_T___getslice__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::vector< double > >::difference_type >(val3);
   try {
@@ -9980,7 +9980,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::difference_type arg2 ;
@@ -9996,17 +9996,17 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setslice____SWIG_0(PyObject *self, Py_s
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___setslice__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___setslice__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_t___setslice__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_T___setslice__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble2d_t___setslice__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble2d_T___setslice__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::vector< double > >::difference_type >(val3);
   try {
@@ -10023,7 +10023,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::difference_type arg2 ;
@@ -10041,27 +10041,27 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setslice____SWIG_1(PyObject *self, Py_s
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___setslice__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___setslice__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_t___setslice__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_T___setslice__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble2d_t___setslice__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble2d_T___setslice__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::vector< double > >::difference_type >(val3);
   {
     std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > *ptr = (std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > *)0;
     res4 = swig::asptr(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vdouble2d_t___setslice__" "', argument " "4"" of type '" "std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vdouble2d_T___setslice__" "', argument " "4"" of type '" "std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_t___setslice__" "', argument " "4"" of type '" "std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_T___setslice__" "', argument " "4"" of type '" "std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > const &""'"); 
     }
     arg4 = ptr;
   }
@@ -10081,13 +10081,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___setslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___setslice__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_t___setslice__", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_T___setslice__", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -10104,7 +10104,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setslice__(PyObject *self, PyObject *ar
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vdouble2d_t___setslice____SWIG_0(self, argc, argv);
+          return _wrap_vdouble2d_T___setslice____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -10127,7 +10127,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setslice__(PyObject *self, PyObject *ar
           int res = swig::asptr(argv[3], (std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > >**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vdouble2d_t___setslice____SWIG_1(self, argc, argv);
+            return _wrap_vdouble2d_T___setslice____SWIG_1(self, argc, argv);
           }
         }
       }
@@ -10135,7 +10135,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setslice__(PyObject *self, PyObject *ar
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_t___setslice__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_T___setslice__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< double > >::__setslice__(std::vector< std::vector< double > >::difference_type,std::vector< std::vector< double > >::difference_type)\n"
     "    std::vector< std::vector< double > >::__setslice__(std::vector< std::vector< double > >::difference_type,std::vector< std::vector< double > >::difference_type,std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > const &)\n");
@@ -10143,7 +10143,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___delslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___delslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::difference_type arg2 ;
@@ -10157,20 +10157,20 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___delslice__(PyObject *self, PyObject *ar
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_t___delslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_T___delslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___delslice__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___delslice__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_t___delslice__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_T___delslice__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble2d_t___delslice__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble2d_T___delslice__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::vector< double > >::difference_type >(val3);
   try {
@@ -10187,7 +10187,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::difference_type arg2 ;
@@ -10200,12 +10200,12 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___delitem____SWIG_0(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___delitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___delitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_t___delitem__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_T___delitem__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< double > >::difference_type >(val2);
   try {
@@ -10222,7 +10222,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -10234,12 +10234,12 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___getitem____SWIG_0(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___getitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___getitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -10257,7 +10257,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -10270,12 +10270,12 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setitem____SWIG_0(PyObject *self, Py_ss
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -10283,10 +10283,10 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setitem____SWIG_0(PyObject *self, Py_ss
     std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > *ptr = (std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble2d_t___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble2d_T___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_t___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_T___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > const &""'"); 
     }
     arg3 = ptr;
   }
@@ -10306,7 +10306,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -10317,12 +10317,12 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setitem____SWIG_1(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -10340,7 +10340,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -10351,12 +10351,12 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___delitem____SWIG_1(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___delitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___delitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -10374,13 +10374,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___delitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___delitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_t___delitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_T___delitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -10391,7 +10391,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___delitem__(PyObject *self, PyObject *arg
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vdouble2d_t___delitem____SWIG_1(self, argc, argv);
+        return _wrap_vdouble2d_T___delitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -10405,13 +10405,13 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___delitem__(PyObject *self, PyObject *arg
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vdouble2d_t___delitem____SWIG_0(self, argc, argv);
+        return _wrap_vdouble2d_T___delitem____SWIG_0(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_t___delitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_T___delitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< double > >::__delitem__(std::vector< std::vector< double > >::difference_type)\n"
     "    std::vector< std::vector< double > >::__delitem__(SWIGPY_SLICEOBJECT *)\n");
@@ -10419,7 +10419,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::difference_type arg2 ;
@@ -10433,12 +10433,12 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___getitem____SWIG_1(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___getitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___getitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_t___getitem__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_T___getitem__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< double > >::difference_type >(val2);
   try {
@@ -10454,13 +10454,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___getitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___getitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_t___getitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_T___getitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -10471,7 +10471,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___getitem__(PyObject *self, PyObject *arg
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vdouble2d_t___getitem____SWIG_0(self, argc, argv);
+        return _wrap_vdouble2d_T___getitem____SWIG_0(self, argc, argv);
       }
     }
   }
@@ -10485,13 +10485,13 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___getitem__(PyObject *self, PyObject *arg
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vdouble2d_t___getitem____SWIG_1(self, argc, argv);
+        return _wrap_vdouble2d_T___getitem____SWIG_1(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_t___getitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_T___getitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< double > >::__getitem__(SWIGPY_SLICEOBJECT *)\n"
     "    std::vector< std::vector< double > >::__getitem__(std::vector< std::vector< double > >::difference_type) const\n");
@@ -10499,7 +10499,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::difference_type arg2 ;
@@ -10514,22 +10514,22 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setitem____SWIG_2(PyObject *self, Py_ss
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_t___setitem__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_T___setitem__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< double > >::difference_type >(val2);
   {
     std::vector< double,std::allocator< double > > *ptr = (std::vector< double,std::allocator< double > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble2d_t___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble2d_T___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_t___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_T___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -10547,13 +10547,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___setitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___setitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_t___setitem__", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_T___setitem__", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -10564,7 +10564,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setitem__(PyObject *self, PyObject *arg
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vdouble2d_t___setitem____SWIG_1(self, argc, argv);
+        return _wrap_vdouble2d_T___setitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -10580,7 +10580,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setitem__(PyObject *self, PyObject *arg
         int res = swig::asptr(argv[2], (std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vdouble2d_t___setitem____SWIG_0(self, argc, argv);
+          return _wrap_vdouble2d_T___setitem____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -10598,14 +10598,14 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setitem__(PyObject *self, PyObject *arg
         int res = swig::asptr(argv[2], (std::vector< double,std::allocator< double > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vdouble2d_t___setitem____SWIG_2(self, argc, argv);
+          return _wrap_vdouble2d_T___setitem____SWIG_2(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_t___setitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_T___setitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< double > >::__setitem__(SWIGPY_SLICEOBJECT *,std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > const &)\n"
     "    std::vector< std::vector< double > >::__setitem__(SWIGPY_SLICEOBJECT *)\n"
@@ -10614,7 +10614,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_pop(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_pop(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -10627,7 +10627,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_pop(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_pop" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_pop" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   try {
@@ -10642,7 +10642,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_append(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_append(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::value_type *arg2 = 0 ;
@@ -10652,20 +10652,20 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_append(PyObject *self, PyObject *args) {
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_t_append", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_T_append", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_append" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_append" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   {
     std::vector< double,std::allocator< double > > *ptr = (std::vector< double,std::allocator< double > > *)0;
     res2 = swig::asptr(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vdouble2d_t_append" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vdouble2d_T_append" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_t_append" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_T_append" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -10679,7 +10679,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vdouble2d_t__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
+SWIGINTERN PyObject *_wrap_new_vdouble2d_T__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *result = 0 ;
   
@@ -10693,7 +10693,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vdouble2d_t__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vdouble2d_T__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double,std::allocator< double > > > *arg1 = 0 ;
   int res1 = SWIG_OLDOBJ ;
@@ -10705,10 +10705,10 @@ SWIGINTERN PyObject *_wrap_new_vdouble2d_t__SWIG_1(PyObject *self, Py_ssize_t no
     std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > *ptr = (std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > *)0;
     res1 = swig::asptr(swig_obj[0], &ptr);
     if (!SWIG_IsOK(res1)) {
-      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vdouble2d_t" "', argument " "1"" of type '" "std::vector< std::vector< double,std::allocator< double > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vdouble2d_T" "', argument " "1"" of type '" "std::vector< std::vector< double,std::allocator< double > > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vdouble2d_t" "', argument " "1"" of type '" "std::vector< std::vector< double,std::allocator< double > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vdouble2d_T" "', argument " "1"" of type '" "std::vector< std::vector< double,std::allocator< double > > > const &""'"); 
     }
     arg1 = ptr;
   }
@@ -10722,7 +10722,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_empty(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_empty(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -10735,7 +10735,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_empty(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_empty" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_empty" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = (bool)((std::vector< std::vector< double > > const *)arg1)->empty();
@@ -10746,7 +10746,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_size(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_size(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -10759,7 +10759,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_size(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_size" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_size" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = ((std::vector< std::vector< double > > const *)arg1)->size();
@@ -10770,7 +10770,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_swap(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_swap(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double,std::allocator< double > > > *arg2 = 0 ;
@@ -10781,18 +10781,18 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_swap(PyObject *self, PyObject *args) {
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_t_swap", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_T_swap", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_swap" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_swap" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], &argp2, SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t,  0 );
   if (!SWIG_IsOK(res2)) {
-    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vdouble2d_t_swap" "', argument " "2"" of type '" "std::vector< std::vector< double,std::allocator< double > > > &""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vdouble2d_T_swap" "', argument " "2"" of type '" "std::vector< std::vector< double,std::allocator< double > > > &""'"); 
   }
   if (!argp2) {
-    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_t_swap" "', argument " "2"" of type '" "std::vector< std::vector< double,std::allocator< double > > > &""'"); 
+    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_T_swap" "', argument " "2"" of type '" "std::vector< std::vector< double,std::allocator< double > > > &""'"); 
   }
   arg2 = reinterpret_cast< std::vector< std::vector< double,std::allocator< double > > > * >(argp2);
   (arg1)->swap(*arg2);
@@ -10803,7 +10803,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_begin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_begin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -10816,7 +10816,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_begin(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_begin" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_begin" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = (arg1)->begin();
@@ -10828,7 +10828,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_end(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_end(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -10841,7 +10841,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_end(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_end" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_end" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = (arg1)->end();
@@ -10853,7 +10853,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_rbegin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_rbegin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -10866,7 +10866,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_rbegin(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_rbegin" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_rbegin" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = (arg1)->rbegin();
@@ -10878,7 +10878,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_rend(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_rend(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -10891,7 +10891,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_rend(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_rend" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_rend" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = (arg1)->rend();
@@ -10903,7 +10903,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_clear(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_clear(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -10915,7 +10915,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_clear(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_clear" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_clear" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   (arg1)->clear();
@@ -10926,7 +10926,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_get_allocator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_get_allocator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -10939,7 +10939,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_get_allocator(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_get_allocator" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_get_allocator" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = ((std::vector< std::vector< double > > const *)arg1)->get_allocator();
@@ -10950,7 +10950,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vdouble2d_t__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vdouble2d_T__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > >::size_type arg1 ;
   size_t val1 ;
@@ -10961,7 +10961,7 @@ SWIGINTERN PyObject *_wrap_new_vdouble2d_t__SWIG_2(PyObject *self, Py_ssize_t no
   if ((nobjs < 1) || (nobjs > 1)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vdouble2d_t" "', argument " "1"" of type '" "std::vector< std::vector< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vdouble2d_T" "', argument " "1"" of type '" "std::vector< std::vector< double > >::size_type""'");
   } 
   arg1 = static_cast< std::vector< std::vector< double > >::size_type >(val1);
   result = (std::vector< std::vector< double > > *)new std::vector< std::vector< double > >(arg1);
@@ -10972,7 +10972,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_pop_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_pop_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -10984,7 +10984,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_pop_back(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_pop_back" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_pop_back" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   (arg1)->pop_back();
@@ -10995,7 +10995,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::size_type arg2 ;
@@ -11008,12 +11008,12 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_resize__SWIG_0(PyObject *self, Py_ssize_t
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_resize" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_resize" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_t_resize" "', argument " "2"" of type '" "std::vector< std::vector< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_T_resize" "', argument " "2"" of type '" "std::vector< std::vector< double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< double > >::size_type >(val2);
   (arg1)->resize(arg2);
@@ -11024,7 +11024,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::iterator arg2 ;
@@ -11038,18 +11038,18 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_erase__SWIG_0(PyObject *self, Py_ssize_t
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_erase" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_erase" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t_erase" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T_erase" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t_erase" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T_erase" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
     }
   }
   result = std_vector_Sl_std_vector_Sl_double_Sg__Sg__erase__SWIG_0(arg1,SWIG_STD_MOVE(arg2));
@@ -11061,7 +11061,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::iterator arg2 ;
@@ -11078,29 +11078,29 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_erase__SWIG_1(PyObject *self, Py_ssize_t
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_erase" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_erase" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t_erase" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T_erase" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t_erase" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T_erase" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
     }
   }
   res3 = SWIG_ConvertPtr(swig_obj[2], SWIG_as_voidptrptr(&iter3), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res3) || !iter3) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t_erase" "', argument " "3"" of type '" "std::vector< std::vector< double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T_erase" "', argument " "3"" of type '" "std::vector< std::vector< double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *>(iter3);
     if (iter_t) {
       arg3 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t_erase" "', argument " "3"" of type '" "std::vector< std::vector< double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T_erase" "', argument " "3"" of type '" "std::vector< std::vector< double > >::iterator""'");
     }
   }
   result = std_vector_Sl_std_vector_Sl_double_Sg__Sg__erase__SWIG_1(arg1,SWIG_STD_MOVE(arg2),SWIG_STD_MOVE(arg3));
@@ -11112,13 +11112,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_erase(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_erase(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_t_erase", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_T_erase", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -11129,7 +11129,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_erase(PyObject *self, PyObject *args) {
       int res = SWIG_ConvertPtr(argv[1], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
       _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *>(iter) != 0));
       if (_v) {
-        return _wrap_vdouble2d_t_erase__SWIG_0(self, argc, argv);
+        return _wrap_vdouble2d_T_erase__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -11146,14 +11146,14 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_erase(PyObject *self, PyObject *args) {
         int res = SWIG_ConvertPtr(argv[2], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
         _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *>(iter) != 0));
         if (_v) {
-          return _wrap_vdouble2d_t_erase__SWIG_1(self, argc, argv);
+          return _wrap_vdouble2d_T_erase__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_t_erase'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_T_erase'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< double > >::erase(std::vector< std::vector< double > >::iterator)\n"
     "    std::vector< std::vector< double > >::erase(std::vector< std::vector< double > >::iterator,std::vector< std::vector< double > >::iterator)\n");
@@ -11161,7 +11161,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vdouble2d_t__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vdouble2d_T__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > >::size_type arg1 ;
   std::vector< std::vector< double > >::value_type *arg2 = 0 ;
@@ -11174,17 +11174,17 @@ SWIGINTERN PyObject *_wrap_new_vdouble2d_t__SWIG_3(PyObject *self, Py_ssize_t no
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vdouble2d_t" "', argument " "1"" of type '" "std::vector< std::vector< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vdouble2d_T" "', argument " "1"" of type '" "std::vector< std::vector< double > >::size_type""'");
   } 
   arg1 = static_cast< std::vector< std::vector< double > >::size_type >(val1);
   {
     std::vector< double,std::allocator< double > > *ptr = (std::vector< double,std::allocator< double > > *)0;
     res2 = swig::asptr(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "new_vdouble2d_t" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "new_vdouble2d_T" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vdouble2d_t" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vdouble2d_T" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -11198,16 +11198,16 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vdouble2d_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_new_vdouble2d_T(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vdouble2d_t", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vdouble2d_T", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 0) {
-    return _wrap_new_vdouble2d_t__SWIG_0(self, argc, argv);
+    return _wrap_new_vdouble2d_T__SWIG_0(self, argc, argv);
   }
   if (argc == 1) {
     int _v = 0;
@@ -11216,7 +11216,7 @@ SWIGINTERN PyObject *_wrap_new_vdouble2d_t(PyObject *self, PyObject *args) {
       _v = SWIG_CheckState(res);
     }
     if (_v) {
-      return _wrap_new_vdouble2d_t__SWIG_2(self, argc, argv);
+      return _wrap_new_vdouble2d_T__SWIG_2(self, argc, argv);
     }
   }
   if (argc == 1) {
@@ -11224,7 +11224,7 @@ SWIGINTERN PyObject *_wrap_new_vdouble2d_t(PyObject *self, PyObject *args) {
     int res = swig::asptr(argv[0], (std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > >**)(0));
     _v = SWIG_CheckState(res);
     if (_v) {
-      return _wrap_new_vdouble2d_t__SWIG_1(self, argc, argv);
+      return _wrap_new_vdouble2d_T__SWIG_1(self, argc, argv);
     }
   }
   if (argc == 2) {
@@ -11237,13 +11237,13 @@ SWIGINTERN PyObject *_wrap_new_vdouble2d_t(PyObject *self, PyObject *args) {
       int res = swig::asptr(argv[1], (std::vector< double,std::allocator< double > >**)(0));
       _v = SWIG_CheckState(res);
       if (_v) {
-        return _wrap_new_vdouble2d_t__SWIG_3(self, argc, argv);
+        return _wrap_new_vdouble2d_T__SWIG_3(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vdouble2d_t'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vdouble2d_T'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< double > >::vector()\n"
     "    std::vector< std::vector< double > >::vector(std::vector< std::vector< double,std::allocator< double > > > const &)\n"
@@ -11253,7 +11253,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_push_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_push_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::value_type *arg2 = 0 ;
@@ -11263,20 +11263,20 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_push_back(PyObject *self, PyObject *args)
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_t_push_back", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_T_push_back", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_push_back" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_push_back" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   {
     std::vector< double,std::allocator< double > > *ptr = (std::vector< double,std::allocator< double > > *)0;
     res2 = swig::asptr(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vdouble2d_t_push_back" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vdouble2d_T_push_back" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_t_push_back" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_T_push_back" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -11290,7 +11290,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_front(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_front(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -11303,7 +11303,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_front(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_front" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_front" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = (std::vector< std::vector< double > >::value_type *) &((std::vector< std::vector< double > > const *)arg1)->front();
@@ -11315,7 +11315,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -11328,7 +11328,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_back(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_back" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_back" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = (std::vector< std::vector< double > >::value_type *) &((std::vector< std::vector< double > > const *)arg1)->back();
@@ -11340,7 +11340,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_assign(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_assign(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::size_type arg2 ;
@@ -11353,25 +11353,25 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_assign(PyObject *self, PyObject *args) {
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_t_assign", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_T_assign", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_assign" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_assign" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_t_assign" "', argument " "2"" of type '" "std::vector< std::vector< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_T_assign" "', argument " "2"" of type '" "std::vector< std::vector< double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< double > >::size_type >(val2);
   {
     std::vector< double,std::allocator< double > > *ptr = (std::vector< double,std::allocator< double > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble2d_t_assign" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble2d_T_assign" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_t_assign" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_T_assign" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -11385,7 +11385,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::size_type arg2 ;
@@ -11400,22 +11400,22 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_resize__SWIG_1(PyObject *self, Py_ssize_t
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_resize" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_resize" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_t_resize" "', argument " "2"" of type '" "std::vector< std::vector< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_T_resize" "', argument " "2"" of type '" "std::vector< std::vector< double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< double > >::size_type >(val2);
   {
     std::vector< double,std::allocator< double > > *ptr = (std::vector< double,std::allocator< double > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble2d_t_resize" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble2d_T_resize" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_t_resize" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_T_resize" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -11429,13 +11429,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_resize(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_resize(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_t_resize", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_T_resize", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -11447,7 +11447,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_resize(PyObject *self, PyObject *args) {
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vdouble2d_t_resize__SWIG_0(self, argc, argv);
+        return _wrap_vdouble2d_T_resize__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -11464,14 +11464,14 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_resize(PyObject *self, PyObject *args) {
         int res = swig::asptr(argv[2], (std::vector< double,std::allocator< double > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vdouble2d_t_resize__SWIG_1(self, argc, argv);
+          return _wrap_vdouble2d_T_resize__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_t_resize'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_T_resize'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< double > >::resize(std::vector< std::vector< double > >::size_type)\n"
     "    std::vector< std::vector< double > >::resize(std::vector< std::vector< double > >::size_type,std::vector< std::vector< double > >::value_type const &)\n");
@@ -11479,7 +11479,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::iterator arg2 ;
@@ -11495,28 +11495,28 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_insert__SWIG_0(PyObject *self, Py_ssize_t
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_insert" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_insert" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t_insert" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T_insert" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t_insert" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T_insert" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
     }
   }
   {
     std::vector< double,std::allocator< double > > *ptr = (std::vector< double,std::allocator< double > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble2d_t_insert" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble2d_T_insert" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_t_insert" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_T_insert" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -11531,7 +11531,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::iterator arg2 ;
@@ -11549,33 +11549,33 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_insert__SWIG_1(PyObject *self, Py_ssize_t
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_insert" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_insert" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t_insert" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T_insert" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t_insert" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T_insert" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_size_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble2d_t_insert" "', argument " "3"" of type '" "std::vector< std::vector< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble2d_T_insert" "', argument " "3"" of type '" "std::vector< std::vector< double > >::size_type""'");
   } 
   arg3 = static_cast< std::vector< std::vector< double > >::size_type >(val3);
   {
     std::vector< double,std::allocator< double > > *ptr = (std::vector< double,std::allocator< double > > *)0;
     res4 = swig::asptr(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vdouble2d_t_insert" "', argument " "4"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vdouble2d_T_insert" "', argument " "4"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_t_insert" "', argument " "4"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_T_insert" "', argument " "4"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     arg4 = ptr;
   }
@@ -11589,13 +11589,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_insert(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_insert(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_t_insert", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_T_insert", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -11609,7 +11609,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_insert(PyObject *self, PyObject *args) {
         int res = swig::asptr(argv[2], (std::vector< double,std::allocator< double > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vdouble2d_t_insert__SWIG_0(self, argc, argv);
+          return _wrap_vdouble2d_T_insert__SWIG_0(self, argc, argv);
         }
       }
     }
@@ -11631,7 +11631,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_insert(PyObject *self, PyObject *args) {
           int res = swig::asptr(argv[3], (std::vector< double,std::allocator< double > >**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vdouble2d_t_insert__SWIG_1(self, argc, argv);
+            return _wrap_vdouble2d_T_insert__SWIG_1(self, argc, argv);
           }
         }
       }
@@ -11639,7 +11639,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_insert(PyObject *self, PyObject *args) {
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_t_insert'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_T_insert'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< double > >::insert(std::vector< std::vector< double > >::iterator,std::vector< std::vector< double > >::value_type const &)\n"
     "    std::vector< std::vector< double > >::insert(std::vector< std::vector< double > >::iterator,std::vector< std::vector< double > >::size_type,std::vector< std::vector< double > >::value_type const &)\n");
@@ -11647,7 +11647,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_reserve(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_reserve(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::size_type arg2 ;
@@ -11658,15 +11658,15 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_reserve(PyObject *self, PyObject *args) {
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_t_reserve", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_T_reserve", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_reserve" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_reserve" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_t_reserve" "', argument " "2"" of type '" "std::vector< std::vector< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_T_reserve" "', argument " "2"" of type '" "std::vector< std::vector< double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< double > >::size_type >(val2);
   (arg1)->reserve(arg2);
@@ -11677,7 +11677,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_capacity(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_capacity(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -11690,7 +11690,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_capacity(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_capacity" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_capacity" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = ((std::vector< std::vector< double > > const *)arg1)->capacity();
@@ -11701,7 +11701,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_delete_vdouble2d_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_delete_vdouble2d_T(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -11713,7 +11713,7 @@ SWIGINTERN PyObject *_wrap_delete_vdouble2d_t(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, SWIG_POINTER_DISOWN |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vdouble2d_t" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vdouble2d_T" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   {
@@ -11734,18 +11734,18 @@ fail:
 }
 
 
-SWIGINTERN PyObject *vdouble2d_t_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vdouble2d_T_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   PyObject *obj;
   if (!SWIG_Python_UnpackTuple(args, "swigregister", 1, 1, &obj)) return NULL;
   SWIG_TypeNewClientData(SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, SWIG_NewClientData(obj));
   return SWIG_Py_Void();
 }
 
-SWIGINTERN PyObject *vdouble2d_t_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vdouble2d_T_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   return SWIG_Python_InitShadowInstance(args);
 }
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_iterator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_iterator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   PyObject **arg2 = (PyObject **) 0 ;
@@ -11760,7 +11760,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_iterator(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_iterator" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_iterator" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = (swig::SwigPyIterator *)std_vector_Sl_int_Sg__iterator(arg1,arg2);
@@ -11771,7 +11771,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___nonzero__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___nonzero__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -11784,7 +11784,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___nonzero__(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___nonzero__" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___nonzero__" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = (bool)std_vector_Sl_int_Sg____nonzero__((std::vector< int > const *)arg1);
@@ -11795,7 +11795,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___bool__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___bool__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -11808,7 +11808,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___bool__(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___bool__" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___bool__" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = (bool)std_vector_Sl_int_Sg____bool__((std::vector< int > const *)arg1);
@@ -11819,7 +11819,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___len__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___len__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -11832,7 +11832,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___len__(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___len__" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___len__" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = std_vector_Sl_int_Sg____len__((std::vector< int > const *)arg1);
@@ -11843,7 +11843,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___getslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___getslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::difference_type arg2 ;
@@ -11858,20 +11858,20 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___getslice__(PyObject *self, PyObjec
   std::vector< int,std::allocator< int > > *result = 0 ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_integer_t___getslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_integer_T___getslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___getslice__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___getslice__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t___getslice__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T___getslice__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< int >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_t___getslice__" "', argument " "3"" of type '" "std::vector< int >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_T___getslice__" "', argument " "3"" of type '" "std::vector< int >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< int >::difference_type >(val3);
   try {
@@ -11888,7 +11888,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::difference_type arg2 ;
@@ -11904,17 +11904,17 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setslice____SWIG_0(PyObject *self,
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___setslice__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___setslice__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t___setslice__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T___setslice__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< int >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_t___setslice__" "', argument " "3"" of type '" "std::vector< int >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_T___setslice__" "', argument " "3"" of type '" "std::vector< int >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< int >::difference_type >(val3);
   try {
@@ -11931,7 +11931,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::difference_type arg2 ;
@@ -11949,27 +11949,27 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setslice____SWIG_1(PyObject *self,
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___setslice__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___setslice__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t___setslice__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T___setslice__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< int >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_t___setslice__" "', argument " "3"" of type '" "std::vector< int >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_T___setslice__" "', argument " "3"" of type '" "std::vector< int >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< int >::difference_type >(val3);
   {
     std::vector< int,std::allocator< int > > *ptr = (std::vector< int,std::allocator< int > > *)0;
     res4 = swig::asptr(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_integer_t___setslice__" "', argument " "4"" of type '" "std::vector< int,std::allocator< int > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_integer_T___setslice__" "', argument " "4"" of type '" "std::vector< int,std::allocator< int > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_integer_t___setslice__" "', argument " "4"" of type '" "std::vector< int,std::allocator< int > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_integer_T___setslice__" "', argument " "4"" of type '" "std::vector< int,std::allocator< int > > const &""'"); 
     }
     arg4 = ptr;
   }
@@ -11989,13 +11989,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___setslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___setslice__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_t___setslice__", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_T___setslice__", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -12012,7 +12012,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setslice__(PyObject *self, PyObjec
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_integer_t___setslice____SWIG_0(self, argc, argv);
+          return _wrap_vector_integer_T___setslice____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -12035,7 +12035,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setslice__(PyObject *self, PyObjec
           int res = swig::asptr(argv[3], (std::vector< int,std::allocator< int > >**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vector_integer_t___setslice____SWIG_1(self, argc, argv);
+            return _wrap_vector_integer_T___setslice____SWIG_1(self, argc, argv);
           }
         }
       }
@@ -12043,7 +12043,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setslice__(PyObject *self, PyObjec
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_t___setslice__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_T___setslice__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< int >::__setslice__(std::vector< int >::difference_type,std::vector< int >::difference_type)\n"
     "    std::vector< int >::__setslice__(std::vector< int >::difference_type,std::vector< int >::difference_type,std::vector< int,std::allocator< int > > const &)\n");
@@ -12051,7 +12051,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___delslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___delslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::difference_type arg2 ;
@@ -12065,20 +12065,20 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___delslice__(PyObject *self, PyObjec
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_integer_t___delslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_integer_T___delslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___delslice__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___delslice__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t___delslice__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T___delslice__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< int >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_t___delslice__" "', argument " "3"" of type '" "std::vector< int >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_T___delslice__" "', argument " "3"" of type '" "std::vector< int >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< int >::difference_type >(val3);
   try {
@@ -12095,7 +12095,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::difference_type arg2 ;
@@ -12108,12 +12108,12 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___delitem____SWIG_0(PyObject *self,
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___delitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___delitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t___delitem__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T___delitem__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< int >::difference_type >(val2);
   try {
@@ -12130,7 +12130,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -12142,12 +12142,12 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___getitem____SWIG_0(PyObject *self,
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___getitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___getitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -12165,7 +12165,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -12178,12 +12178,12 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setitem____SWIG_0(PyObject *self,
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___setitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___setitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -12191,10 +12191,10 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setitem____SWIG_0(PyObject *self,
     std::vector< int,std::allocator< int > > *ptr = (std::vector< int,std::allocator< int > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_integer_t___setitem__" "', argument " "3"" of type '" "std::vector< int,std::allocator< int > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_integer_T___setitem__" "', argument " "3"" of type '" "std::vector< int,std::allocator< int > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_integer_t___setitem__" "', argument " "3"" of type '" "std::vector< int,std::allocator< int > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_integer_T___setitem__" "', argument " "3"" of type '" "std::vector< int,std::allocator< int > > const &""'"); 
     }
     arg3 = ptr;
   }
@@ -12214,7 +12214,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -12225,12 +12225,12 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setitem____SWIG_1(PyObject *self,
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___setitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___setitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -12248,7 +12248,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -12259,12 +12259,12 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___delitem____SWIG_1(PyObject *self,
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___delitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___delitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -12282,13 +12282,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___delitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___delitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_t___delitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_T___delitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -12299,7 +12299,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___delitem__(PyObject *self, PyObject
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_integer_t___delitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_integer_T___delitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -12313,13 +12313,13 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___delitem__(PyObject *self, PyObject
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_integer_t___delitem____SWIG_0(self, argc, argv);
+        return _wrap_vector_integer_T___delitem____SWIG_0(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_t___delitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_T___delitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< int >::__delitem__(std::vector< int >::difference_type)\n"
     "    std::vector< int >::__delitem__(SWIGPY_SLICEOBJECT *)\n");
@@ -12327,7 +12327,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::difference_type arg2 ;
@@ -12341,12 +12341,12 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___getitem____SWIG_1(PyObject *self,
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___getitem__" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___getitem__" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t___getitem__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T___getitem__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< int >::difference_type >(val2);
   try {
@@ -12362,13 +12362,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___getitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___getitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_t___getitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_T___getitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -12379,7 +12379,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___getitem__(PyObject *self, PyObject
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_integer_t___getitem____SWIG_0(self, argc, argv);
+        return _wrap_vector_integer_T___getitem____SWIG_0(self, argc, argv);
       }
     }
   }
@@ -12393,13 +12393,13 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___getitem__(PyObject *self, PyObject
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_integer_t___getitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_integer_T___getitem____SWIG_1(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_t___getitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_T___getitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< int >::__getitem__(SWIGPY_SLICEOBJECT *)\n"
     "    std::vector< int >::__getitem__(std::vector< int >::difference_type) const\n");
@@ -12407,7 +12407,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::difference_type arg2 ;
@@ -12424,17 +12424,17 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setitem____SWIG_2(PyObject *self,
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___setitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___setitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t___setitem__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T___setitem__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< int >::difference_type >(val2);
   ecode3 = SWIG_AsVal_int(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_t___setitem__" "', argument " "3"" of type '" "std::vector< int >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_T___setitem__" "', argument " "3"" of type '" "std::vector< int >::value_type""'");
   } 
   temp3 = static_cast< std::vector< int >::value_type >(val3);
   arg3 = &temp3;
@@ -12450,13 +12450,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___setitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___setitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_t___setitem__", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_T___setitem__", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -12467,7 +12467,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setitem__(PyObject *self, PyObject
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_integer_t___setitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_integer_T___setitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -12483,7 +12483,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setitem__(PyObject *self, PyObject
         int res = swig::asptr(argv[2], (std::vector< int,std::allocator< int > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vector_integer_t___setitem____SWIG_0(self, argc, argv);
+          return _wrap_vector_integer_T___setitem____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -12503,14 +12503,14 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setitem__(PyObject *self, PyObject
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_integer_t___setitem____SWIG_2(self, argc, argv);
+          return _wrap_vector_integer_T___setitem____SWIG_2(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_t___setitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_T___setitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< int >::__setitem__(SWIGPY_SLICEOBJECT *,std::vector< int,std::allocator< int > > const &)\n"
     "    std::vector< int >::__setitem__(SWIGPY_SLICEOBJECT *)\n"
@@ -12519,7 +12519,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_pop(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_pop(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -12532,7 +12532,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_pop(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_pop" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_pop" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   try {
@@ -12547,7 +12547,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_append(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_append(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::value_type *arg2 = 0 ;
@@ -12559,15 +12559,15 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_append(PyObject *self, PyObject *arg
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_integer_t_append", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_integer_T_append", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_append" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_append" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_int(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t_append" "', argument " "2"" of type '" "std::vector< int >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T_append" "', argument " "2"" of type '" "std::vector< int >::value_type""'");
   } 
   temp2 = static_cast< std::vector< int >::value_type >(val2);
   arg2 = &temp2;
@@ -12579,7 +12579,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_integer_t__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
+SWIGINTERN PyObject *_wrap_new_vector_integer_T__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
   PyObject *resultobj = 0;
   std::vector< int > *result = 0 ;
   
@@ -12593,7 +12593,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_integer_t__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_integer_T__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = 0 ;
   int res1 = SWIG_OLDOBJ ;
@@ -12605,10 +12605,10 @@ SWIGINTERN PyObject *_wrap_new_vector_integer_t__SWIG_1(PyObject *self, Py_ssize
     std::vector< int,std::allocator< int > > *ptr = (std::vector< int,std::allocator< int > > *)0;
     res1 = swig::asptr(swig_obj[0], &ptr);
     if (!SWIG_IsOK(res1)) {
-      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vector_integer_t" "', argument " "1"" of type '" "std::vector< int > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vector_integer_T" "', argument " "1"" of type '" "std::vector< int > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_integer_t" "', argument " "1"" of type '" "std::vector< int > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_integer_T" "', argument " "1"" of type '" "std::vector< int > const &""'"); 
     }
     arg1 = ptr;
   }
@@ -12622,7 +12622,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_empty(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_empty(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -12635,7 +12635,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_empty(PyObject *self, PyObject *args
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_empty" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_empty" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = (bool)((std::vector< int > const *)arg1)->empty();
@@ -12646,7 +12646,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_size(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_size(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -12659,7 +12659,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_size(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_size" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_size" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = ((std::vector< int > const *)arg1)->size();
@@ -12670,7 +12670,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_swap(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_swap(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int > *arg2 = 0 ;
@@ -12681,18 +12681,18 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_swap(PyObject *self, PyObject *args)
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_integer_t_swap", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_integer_T_swap", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_swap" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_swap" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], &argp2, SWIGTYPE_p_std__vectorT_int_t,  0 );
   if (!SWIG_IsOK(res2)) {
-    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_integer_t_swap" "', argument " "2"" of type '" "std::vector< int > &""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_integer_T_swap" "', argument " "2"" of type '" "std::vector< int > &""'"); 
   }
   if (!argp2) {
-    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_integer_t_swap" "', argument " "2"" of type '" "std::vector< int > &""'"); 
+    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_integer_T_swap" "', argument " "2"" of type '" "std::vector< int > &""'"); 
   }
   arg2 = reinterpret_cast< std::vector< int > * >(argp2);
   (arg1)->swap(*arg2);
@@ -12703,7 +12703,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_begin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_begin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -12716,7 +12716,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_begin(PyObject *self, PyObject *args
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_begin" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_begin" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = (arg1)->begin();
@@ -12728,7 +12728,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_end(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_end(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -12741,7 +12741,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_end(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_end" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_end" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = (arg1)->end();
@@ -12753,7 +12753,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_rbegin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_rbegin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -12766,7 +12766,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_rbegin(PyObject *self, PyObject *arg
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_rbegin" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_rbegin" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = (arg1)->rbegin();
@@ -12778,7 +12778,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_rend(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_rend(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -12791,7 +12791,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_rend(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_rend" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_rend" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = (arg1)->rend();
@@ -12803,7 +12803,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_clear(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_clear(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -12815,7 +12815,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_clear(PyObject *self, PyObject *args
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_clear" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_clear" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   (arg1)->clear();
@@ -12826,7 +12826,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_get_allocator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_get_allocator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -12839,7 +12839,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_get_allocator(PyObject *self, PyObje
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_get_allocator" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_get_allocator" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = ((std::vector< int > const *)arg1)->get_allocator();
@@ -12850,7 +12850,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_integer_t__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_integer_T__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int >::size_type arg1 ;
   size_t val1 ;
@@ -12861,7 +12861,7 @@ SWIGINTERN PyObject *_wrap_new_vector_integer_t__SWIG_2(PyObject *self, Py_ssize
   if ((nobjs < 1) || (nobjs > 1)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_integer_t" "', argument " "1"" of type '" "std::vector< int >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_integer_T" "', argument " "1"" of type '" "std::vector< int >::size_type""'");
   } 
   arg1 = static_cast< std::vector< int >::size_type >(val1);
   result = (std::vector< int > *)new std::vector< int >(arg1);
@@ -12872,7 +12872,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_pop_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_pop_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -12884,7 +12884,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_pop_back(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_pop_back" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_pop_back" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   (arg1)->pop_back();
@@ -12895,7 +12895,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::size_type arg2 ;
@@ -12908,12 +12908,12 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_resize__SWIG_0(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_resize" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_resize" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t_resize" "', argument " "2"" of type '" "std::vector< int >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T_resize" "', argument " "2"" of type '" "std::vector< int >::size_type""'");
   } 
   arg2 = static_cast< std::vector< int >::size_type >(val2);
   (arg1)->resize(arg2);
@@ -12924,7 +12924,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::iterator arg2 ;
@@ -12938,18 +12938,18 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_erase__SWIG_0(PyObject *self, Py_ssi
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_erase" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_erase" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t_erase" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T_erase" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< int >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< int >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t_erase" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T_erase" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
     }
   }
   result = std_vector_Sl_int_Sg__erase__SWIG_0(arg1,SWIG_STD_MOVE(arg2));
@@ -12961,7 +12961,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::iterator arg2 ;
@@ -12978,29 +12978,29 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_erase__SWIG_1(PyObject *self, Py_ssi
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_erase" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_erase" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t_erase" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T_erase" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< int >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< int >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t_erase" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T_erase" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
     }
   }
   res3 = SWIG_ConvertPtr(swig_obj[2], SWIG_as_voidptrptr(&iter3), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res3) || !iter3) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t_erase" "', argument " "3"" of type '" "std::vector< int >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T_erase" "', argument " "3"" of type '" "std::vector< int >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< int >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< int >::iterator > *>(iter3);
     if (iter_t) {
       arg3 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t_erase" "', argument " "3"" of type '" "std::vector< int >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T_erase" "', argument " "3"" of type '" "std::vector< int >::iterator""'");
     }
   }
   result = std_vector_Sl_int_Sg__erase__SWIG_1(arg1,SWIG_STD_MOVE(arg2),SWIG_STD_MOVE(arg3));
@@ -13012,13 +13012,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_erase(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_erase(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_t_erase", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_T_erase", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -13029,7 +13029,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_erase(PyObject *self, PyObject *args
       int res = SWIG_ConvertPtr(argv[1], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
       _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< int >::iterator > *>(iter) != 0));
       if (_v) {
-        return _wrap_vector_integer_t_erase__SWIG_0(self, argc, argv);
+        return _wrap_vector_integer_T_erase__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -13046,14 +13046,14 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_erase(PyObject *self, PyObject *args
         int res = SWIG_ConvertPtr(argv[2], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
         _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< int >::iterator > *>(iter) != 0));
         if (_v) {
-          return _wrap_vector_integer_t_erase__SWIG_1(self, argc, argv);
+          return _wrap_vector_integer_T_erase__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_t_erase'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_T_erase'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< int >::erase(std::vector< int >::iterator)\n"
     "    std::vector< int >::erase(std::vector< int >::iterator,std::vector< int >::iterator)\n");
@@ -13061,7 +13061,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_integer_t__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_integer_T__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int >::size_type arg1 ;
   std::vector< int >::value_type *arg2 = 0 ;
@@ -13076,12 +13076,12 @@ SWIGINTERN PyObject *_wrap_new_vector_integer_t__SWIG_3(PyObject *self, Py_ssize
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_integer_t" "', argument " "1"" of type '" "std::vector< int >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_integer_T" "', argument " "1"" of type '" "std::vector< int >::size_type""'");
   } 
   arg1 = static_cast< std::vector< int >::size_type >(val1);
   ecode2 = SWIG_AsVal_int(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "new_vector_integer_t" "', argument " "2"" of type '" "std::vector< int >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "new_vector_integer_T" "', argument " "2"" of type '" "std::vector< int >::value_type""'");
   } 
   temp2 = static_cast< std::vector< int >::value_type >(val2);
   arg2 = &temp2;
@@ -13093,16 +13093,16 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_integer_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_new_vector_integer_T(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vector_integer_t", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vector_integer_T", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 0) {
-    return _wrap_new_vector_integer_t__SWIG_0(self, argc, argv);
+    return _wrap_new_vector_integer_T__SWIG_0(self, argc, argv);
   }
   if (argc == 1) {
     int _v = 0;
@@ -13111,7 +13111,7 @@ SWIGINTERN PyObject *_wrap_new_vector_integer_t(PyObject *self, PyObject *args)
       _v = SWIG_CheckState(res);
     }
     if (_v) {
-      return _wrap_new_vector_integer_t__SWIG_2(self, argc, argv);
+      return _wrap_new_vector_integer_T__SWIG_2(self, argc, argv);
     }
   }
   if (argc == 1) {
@@ -13119,7 +13119,7 @@ SWIGINTERN PyObject *_wrap_new_vector_integer_t(PyObject *self, PyObject *args)
     int res = swig::asptr(argv[0], (std::vector< int,std::allocator< int > >**)(0));
     _v = SWIG_CheckState(res);
     if (_v) {
-      return _wrap_new_vector_integer_t__SWIG_1(self, argc, argv);
+      return _wrap_new_vector_integer_T__SWIG_1(self, argc, argv);
     }
   }
   if (argc == 2) {
@@ -13134,13 +13134,13 @@ SWIGINTERN PyObject *_wrap_new_vector_integer_t(PyObject *self, PyObject *args)
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_new_vector_integer_t__SWIG_3(self, argc, argv);
+        return _wrap_new_vector_integer_T__SWIG_3(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vector_integer_t'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vector_integer_T'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< int >::vector()\n"
     "    std::vector< int >::vector(std::vector< int > const &)\n"
@@ -13150,7 +13150,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_push_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_push_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::value_type *arg2 = 0 ;
@@ -13162,15 +13162,15 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_push_back(PyObject *self, PyObject *
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_integer_t_push_back", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_integer_T_push_back", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_push_back" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_push_back" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_int(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t_push_back" "', argument " "2"" of type '" "std::vector< int >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T_push_back" "', argument " "2"" of type '" "std::vector< int >::value_type""'");
   } 
   temp2 = static_cast< std::vector< int >::value_type >(val2);
   arg2 = &temp2;
@@ -13182,7 +13182,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_front(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_front(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -13195,7 +13195,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_front(PyObject *self, PyObject *args
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_front" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_front" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = (std::vector< int >::value_type *) &((std::vector< int > const *)arg1)->front();
@@ -13207,7 +13207,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -13220,7 +13220,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_back(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_back" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_back" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = (std::vector< int >::value_type *) &((std::vector< int > const *)arg1)->back();
@@ -13232,7 +13232,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_assign(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_assign(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::size_type arg2 ;
@@ -13247,20 +13247,20 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_assign(PyObject *self, PyObject *arg
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_integer_t_assign", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_integer_T_assign", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_assign" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_assign" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t_assign" "', argument " "2"" of type '" "std::vector< int >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T_assign" "', argument " "2"" of type '" "std::vector< int >::size_type""'");
   } 
   arg2 = static_cast< std::vector< int >::size_type >(val2);
   ecode3 = SWIG_AsVal_int(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_t_assign" "', argument " "3"" of type '" "std::vector< int >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_T_assign" "', argument " "3"" of type '" "std::vector< int >::value_type""'");
   } 
   temp3 = static_cast< std::vector< int >::value_type >(val3);
   arg3 = &temp3;
@@ -13272,7 +13272,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::size_type arg2 ;
@@ -13289,17 +13289,17 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_resize__SWIG_1(PyObject *self, Py_ss
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_resize" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_resize" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t_resize" "', argument " "2"" of type '" "std::vector< int >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T_resize" "', argument " "2"" of type '" "std::vector< int >::size_type""'");
   } 
   arg2 = static_cast< std::vector< int >::size_type >(val2);
   ecode3 = SWIG_AsVal_int(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_t_resize" "', argument " "3"" of type '" "std::vector< int >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_T_resize" "', argument " "3"" of type '" "std::vector< int >::value_type""'");
   } 
   temp3 = static_cast< std::vector< int >::value_type >(val3);
   arg3 = &temp3;
@@ -13311,13 +13311,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_resize(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_resize(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_t_resize", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_T_resize", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -13329,7 +13329,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_resize(PyObject *self, PyObject *arg
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_integer_t_resize__SWIG_0(self, argc, argv);
+        return _wrap_vector_integer_T_resize__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -13348,14 +13348,14 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_resize(PyObject *self, PyObject *arg
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_integer_t_resize__SWIG_1(self, argc, argv);
+          return _wrap_vector_integer_T_resize__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_t_resize'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_T_resize'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< int >::resize(std::vector< int >::size_type)\n"
     "    std::vector< int >::resize(std::vector< int >::size_type,std::vector< int >::value_type const &)\n");
@@ -13363,7 +13363,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::iterator arg2 ;
@@ -13381,23 +13381,23 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_insert__SWIG_0(PyObject *self, Py_ss
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_insert" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_insert" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t_insert" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T_insert" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< int >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< int >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t_insert" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T_insert" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_int(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_t_insert" "', argument " "3"" of type '" "std::vector< int >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_T_insert" "', argument " "3"" of type '" "std::vector< int >::value_type""'");
   } 
   temp3 = static_cast< std::vector< int >::value_type >(val3);
   arg3 = &temp3;
@@ -13410,7 +13410,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::iterator arg2 ;
@@ -13430,28 +13430,28 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_insert__SWIG_1(PyObject *self, Py_ss
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_insert" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_insert" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t_insert" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T_insert" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< int >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< int >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t_insert" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T_insert" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_size_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_t_insert" "', argument " "3"" of type '" "std::vector< int >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_T_insert" "', argument " "3"" of type '" "std::vector< int >::size_type""'");
   } 
   arg3 = static_cast< std::vector< int >::size_type >(val3);
   ecode4 = SWIG_AsVal_int(swig_obj[3], &val4);
   if (!SWIG_IsOK(ecode4)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode4), "in method '" "vector_integer_t_insert" "', argument " "4"" of type '" "std::vector< int >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode4), "in method '" "vector_integer_T_insert" "', argument " "4"" of type '" "std::vector< int >::value_type""'");
   } 
   temp4 = static_cast< std::vector< int >::value_type >(val4);
   arg4 = &temp4;
@@ -13463,13 +13463,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_insert(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_insert(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_t_insert", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_T_insert", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -13485,7 +13485,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_insert(PyObject *self, PyObject *arg
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_integer_t_insert__SWIG_0(self, argc, argv);
+          return _wrap_vector_integer_T_insert__SWIG_0(self, argc, argv);
         }
       }
     }
@@ -13509,7 +13509,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_insert(PyObject *self, PyObject *arg
             _v = SWIG_CheckState(res);
           }
           if (_v) {
-            return _wrap_vector_integer_t_insert__SWIG_1(self, argc, argv);
+            return _wrap_vector_integer_T_insert__SWIG_1(self, argc, argv);
           }
         }
       }
@@ -13517,7 +13517,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_insert(PyObject *self, PyObject *arg
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_t_insert'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_T_insert'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< int >::insert(std::vector< int >::iterator,std::vector< int >::value_type const &)\n"
     "    std::vector< int >::insert(std::vector< int >::iterator,std::vector< int >::size_type,std::vector< int >::value_type const &)\n");
@@ -13525,7 +13525,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_reserve(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_reserve(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::size_type arg2 ;
@@ -13536,15 +13536,15 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_reserve(PyObject *self, PyObject *ar
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_integer_t_reserve", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_integer_T_reserve", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_reserve" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_reserve" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t_reserve" "', argument " "2"" of type '" "std::vector< int >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T_reserve" "', argument " "2"" of type '" "std::vector< int >::size_type""'");
   } 
   arg2 = static_cast< std::vector< int >::size_type >(val2);
   (arg1)->reserve(arg2);
@@ -13555,7 +13555,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_capacity(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_capacity(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -13568,7 +13568,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_capacity(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_capacity" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_capacity" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = ((std::vector< int > const *)arg1)->capacity();
@@ -13579,7 +13579,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_delete_vector_integer_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_delete_vector_integer_T(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -13591,7 +13591,7 @@ SWIGINTERN PyObject *_wrap_delete_vector_integer_t(PyObject *self, PyObject *arg
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, SWIG_POINTER_DISOWN |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vector_integer_t" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vector_integer_T" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   {
@@ -13612,18 +13612,18 @@ fail:
 }
 
 
-SWIGINTERN PyObject *vector_integer_t_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vector_integer_T_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   PyObject *obj;
   if (!SWIG_Python_UnpackTuple(args, "swigregister", 1, 1, &obj)) return NULL;
   SWIG_TypeNewClientData(SWIGTYPE_p_std__vectorT_int_t, SWIG_NewClientData(obj));
   return SWIG_Py_Void();
 }
 
-SWIGINTERN PyObject *vector_integer_t_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vector_integer_T_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   return SWIG_Python_InitShadowInstance(args);
 }
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_iterator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_iterator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   PyObject **arg2 = (PyObject **) 0 ;
@@ -13638,7 +13638,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_iterator(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_iterator" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_iterator" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = (swig::SwigPyIterator *)std_vector_Sl_std_vector_Sl_int_Sg__Sg__iterator(arg1,arg2);
@@ -13649,7 +13649,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___nonzero__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___nonzero__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -13662,7 +13662,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___nonzero__(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___nonzero__" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___nonzero__" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = (bool)std_vector_Sl_std_vector_Sl_int_Sg__Sg____nonzero__((std::vector< std::vector< int > > const *)arg1);
@@ -13673,7 +13673,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___bool__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___bool__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -13686,7 +13686,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___bool__(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___bool__" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___bool__" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = (bool)std_vector_Sl_std_vector_Sl_int_Sg__Sg____bool__((std::vector< std::vector< int > > const *)arg1);
@@ -13697,7 +13697,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___len__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___len__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -13710,7 +13710,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___len__(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___len__" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___len__" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = std_vector_Sl_std_vector_Sl_int_Sg__Sg____len__((std::vector< std::vector< int > > const *)arg1);
@@ -13721,7 +13721,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___getslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___getslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::difference_type arg2 ;
@@ -13736,20 +13736,20 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___getslice__(PyObject *self, PyObject *a
   std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > *result = 0 ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_t___getslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_T___getslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___getslice__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___getslice__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_t___getslice__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_T___getslice__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< int > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vinteger2d_t___getslice__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vinteger2d_T___getslice__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::vector< int > >::difference_type >(val3);
   try {
@@ -13766,7 +13766,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::difference_type arg2 ;
@@ -13782,17 +13782,17 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setslice____SWIG_0(PyObject *self, Py_
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___setslice__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___setslice__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_t___setslice__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_T___setslice__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< int > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vinteger2d_t___setslice__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vinteger2d_T___setslice__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::vector< int > >::difference_type >(val3);
   try {
@@ -13809,7 +13809,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::difference_type arg2 ;
@@ -13827,27 +13827,27 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setslice____SWIG_1(PyObject *self, Py_
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___setslice__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___setslice__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_t___setslice__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_T___setslice__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< int > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vinteger2d_t___setslice__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vinteger2d_T___setslice__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::vector< int > >::difference_type >(val3);
   {
     std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > *ptr = (std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > *)0;
     res4 = swig::asptr(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vinteger2d_t___setslice__" "', argument " "4"" of type '" "std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vinteger2d_T___setslice__" "', argument " "4"" of type '" "std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_t___setslice__" "', argument " "4"" of type '" "std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_T___setslice__" "', argument " "4"" of type '" "std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > const &""'"); 
     }
     arg4 = ptr;
   }
@@ -13867,13 +13867,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___setslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___setslice__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_t___setslice__", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_T___setslice__", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -13890,7 +13890,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setslice__(PyObject *self, PyObject *a
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vinteger2d_t___setslice____SWIG_0(self, argc, argv);
+          return _wrap_vinteger2d_T___setslice____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -13913,7 +13913,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setslice__(PyObject *self, PyObject *a
           int res = swig::asptr(argv[3], (std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > >**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vinteger2d_t___setslice____SWIG_1(self, argc, argv);
+            return _wrap_vinteger2d_T___setslice____SWIG_1(self, argc, argv);
           }
         }
       }
@@ -13921,7 +13921,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setslice__(PyObject *self, PyObject *a
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_t___setslice__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_T___setslice__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< int > >::__setslice__(std::vector< std::vector< int > >::difference_type,std::vector< std::vector< int > >::difference_type)\n"
     "    std::vector< std::vector< int > >::__setslice__(std::vector< std::vector< int > >::difference_type,std::vector< std::vector< int > >::difference_type,std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > const &)\n");
@@ -13929,7 +13929,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___delslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___delslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::difference_type arg2 ;
@@ -13943,20 +13943,20 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___delslice__(PyObject *self, PyObject *a
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_t___delslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_T___delslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___delslice__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___delslice__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_t___delslice__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_T___delslice__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< int > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vinteger2d_t___delslice__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vinteger2d_T___delslice__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::vector< int > >::difference_type >(val3);
   try {
@@ -13973,7 +13973,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::difference_type arg2 ;
@@ -13986,12 +13986,12 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___delitem____SWIG_0(PyObject *self, Py_s
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___delitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___delitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_t___delitem__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_T___delitem__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< int > >::difference_type >(val2);
   try {
@@ -14008,7 +14008,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -14020,12 +14020,12 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___getitem____SWIG_0(PyObject *self, Py_s
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___getitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___getitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -14043,7 +14043,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -14056,12 +14056,12 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setitem____SWIG_0(PyObject *self, Py_s
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -14069,10 +14069,10 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setitem____SWIG_0(PyObject *self, Py_s
     std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > *ptr = (std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vinteger2d_t___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vinteger2d_T___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_t___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_T___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > const &""'"); 
     }
     arg3 = ptr;
   }
@@ -14092,7 +14092,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -14103,12 +14103,12 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setitem____SWIG_1(PyObject *self, Py_s
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -14126,7 +14126,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -14137,12 +14137,12 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___delitem____SWIG_1(PyObject *self, Py_s
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___delitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___delitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -14160,13 +14160,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___delitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___delitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_t___delitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_T___delitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -14177,7 +14177,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___delitem__(PyObject *self, PyObject *ar
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vinteger2d_t___delitem____SWIG_1(self, argc, argv);
+        return _wrap_vinteger2d_T___delitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -14191,13 +14191,13 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___delitem__(PyObject *self, PyObject *ar
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vinteger2d_t___delitem____SWIG_0(self, argc, argv);
+        return _wrap_vinteger2d_T___delitem____SWIG_0(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_t___delitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_T___delitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< int > >::__delitem__(std::vector< std::vector< int > >::difference_type)\n"
     "    std::vector< std::vector< int > >::__delitem__(SWIGPY_SLICEOBJECT *)\n");
@@ -14205,7 +14205,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::difference_type arg2 ;
@@ -14219,12 +14219,12 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___getitem____SWIG_1(PyObject *self, Py_s
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___getitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___getitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_t___getitem__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_T___getitem__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< int > >::difference_type >(val2);
   try {
@@ -14240,13 +14240,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___getitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___getitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_t___getitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_T___getitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -14257,7 +14257,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___getitem__(PyObject *self, PyObject *ar
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vinteger2d_t___getitem____SWIG_0(self, argc, argv);
+        return _wrap_vinteger2d_T___getitem____SWIG_0(self, argc, argv);
       }
     }
   }
@@ -14271,13 +14271,13 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___getitem__(PyObject *self, PyObject *ar
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vinteger2d_t___getitem____SWIG_1(self, argc, argv);
+        return _wrap_vinteger2d_T___getitem____SWIG_1(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_t___getitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_T___getitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< int > >::__getitem__(SWIGPY_SLICEOBJECT *)\n"
     "    std::vector< std::vector< int > >::__getitem__(std::vector< std::vector< int > >::difference_type) const\n");
@@ -14285,7 +14285,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::difference_type arg2 ;
@@ -14300,22 +14300,22 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setitem____SWIG_2(PyObject *self, Py_s
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_t___setitem__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_T___setitem__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< int > >::difference_type >(val2);
   {
     std::vector< int,std::allocator< int > > *ptr = (std::vector< int,std::allocator< int > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vinteger2d_t___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vinteger2d_T___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_t___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_T___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -14333,13 +14333,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___setitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___setitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_t___setitem__", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_T___setitem__", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -14350,7 +14350,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setitem__(PyObject *self, PyObject *ar
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vinteger2d_t___setitem____SWIG_1(self, argc, argv);
+        return _wrap_vinteger2d_T___setitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -14366,7 +14366,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setitem__(PyObject *self, PyObject *ar
         int res = swig::asptr(argv[2], (std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vinteger2d_t___setitem____SWIG_0(self, argc, argv);
+          return _wrap_vinteger2d_T___setitem____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -14384,14 +14384,14 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setitem__(PyObject *self, PyObject *ar
         int res = swig::asptr(argv[2], (std::vector< int,std::allocator< int > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vinteger2d_t___setitem____SWIG_2(self, argc, argv);
+          return _wrap_vinteger2d_T___setitem____SWIG_2(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_t___setitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_T___setitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< int > >::__setitem__(SWIGPY_SLICEOBJECT *,std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > const &)\n"
     "    std::vector< std::vector< int > >::__setitem__(SWIGPY_SLICEOBJECT *)\n"
@@ -14400,7 +14400,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_pop(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_pop(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -14413,7 +14413,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_pop(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_pop" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_pop" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   try {
@@ -14428,7 +14428,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_append(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_append(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::value_type *arg2 = 0 ;
@@ -14438,20 +14438,20 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_append(PyObject *self, PyObject *args) {
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_t_append", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_T_append", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_append" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_append" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   {
     std::vector< int,std::allocator< int > > *ptr = (std::vector< int,std::allocator< int > > *)0;
     res2 = swig::asptr(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vinteger2d_t_append" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vinteger2d_T_append" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_t_append" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_T_append" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -14465,7 +14465,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vinteger2d_t__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
+SWIGINTERN PyObject *_wrap_new_vinteger2d_T__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *result = 0 ;
   
@@ -14479,7 +14479,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vinteger2d_t__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vinteger2d_T__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int,std::allocator< int > > > *arg1 = 0 ;
   int res1 = SWIG_OLDOBJ ;
@@ -14491,10 +14491,10 @@ SWIGINTERN PyObject *_wrap_new_vinteger2d_t__SWIG_1(PyObject *self, Py_ssize_t n
     std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > *ptr = (std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > *)0;
     res1 = swig::asptr(swig_obj[0], &ptr);
     if (!SWIG_IsOK(res1)) {
-      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vinteger2d_t" "', argument " "1"" of type '" "std::vector< std::vector< int,std::allocator< int > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vinteger2d_T" "', argument " "1"" of type '" "std::vector< std::vector< int,std::allocator< int > > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vinteger2d_t" "', argument " "1"" of type '" "std::vector< std::vector< int,std::allocator< int > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vinteger2d_T" "', argument " "1"" of type '" "std::vector< std::vector< int,std::allocator< int > > > const &""'"); 
     }
     arg1 = ptr;
   }
@@ -14508,7 +14508,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_empty(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_empty(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -14521,7 +14521,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_empty(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_empty" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_empty" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = (bool)((std::vector< std::vector< int > > const *)arg1)->empty();
@@ -14532,7 +14532,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_size(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_size(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -14545,7 +14545,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_size(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_size" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_size" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = ((std::vector< std::vector< int > > const *)arg1)->size();
@@ -14556,7 +14556,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_swap(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_swap(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int,std::allocator< int > > > *arg2 = 0 ;
@@ -14567,18 +14567,18 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_swap(PyObject *self, PyObject *args) {
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_t_swap", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_T_swap", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_swap" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_swap" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], &argp2, SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t,  0 );
   if (!SWIG_IsOK(res2)) {
-    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vinteger2d_t_swap" "', argument " "2"" of type '" "std::vector< std::vector< int,std::allocator< int > > > &""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vinteger2d_T_swap" "', argument " "2"" of type '" "std::vector< std::vector< int,std::allocator< int > > > &""'"); 
   }
   if (!argp2) {
-    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_t_swap" "', argument " "2"" of type '" "std::vector< std::vector< int,std::allocator< int > > > &""'"); 
+    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_T_swap" "', argument " "2"" of type '" "std::vector< std::vector< int,std::allocator< int > > > &""'"); 
   }
   arg2 = reinterpret_cast< std::vector< std::vector< int,std::allocator< int > > > * >(argp2);
   (arg1)->swap(*arg2);
@@ -14589,7 +14589,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_begin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_begin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -14602,7 +14602,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_begin(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_begin" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_begin" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = (arg1)->begin();
@@ -14614,7 +14614,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_end(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_end(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -14627,7 +14627,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_end(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_end" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_end" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = (arg1)->end();
@@ -14639,7 +14639,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_rbegin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_rbegin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -14652,7 +14652,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_rbegin(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_rbegin" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_rbegin" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = (arg1)->rbegin();
@@ -14664,7 +14664,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_rend(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_rend(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -14677,7 +14677,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_rend(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_rend" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_rend" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = (arg1)->rend();
@@ -14689,7 +14689,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_clear(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_clear(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -14701,7 +14701,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_clear(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_clear" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_clear" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   (arg1)->clear();
@@ -14712,7 +14712,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_get_allocator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_get_allocator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -14725,7 +14725,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_get_allocator(PyObject *self, PyObject *
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_get_allocator" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_get_allocator" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = ((std::vector< std::vector< int > > const *)arg1)->get_allocator();
@@ -14736,7 +14736,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vinteger2d_t__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vinteger2d_T__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > >::size_type arg1 ;
   size_t val1 ;
@@ -14747,7 +14747,7 @@ SWIGINTERN PyObject *_wrap_new_vinteger2d_t__SWIG_2(PyObject *self, Py_ssize_t n
   if ((nobjs < 1) || (nobjs > 1)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vinteger2d_t" "', argument " "1"" of type '" "std::vector< std::vector< int > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vinteger2d_T" "', argument " "1"" of type '" "std::vector< std::vector< int > >::size_type""'");
   } 
   arg1 = static_cast< std::vector< std::vector< int > >::size_type >(val1);
   result = (std::vector< std::vector< int > > *)new std::vector< std::vector< int > >(arg1);
@@ -14758,7 +14758,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_pop_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_pop_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -14770,7 +14770,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_pop_back(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_pop_back" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_pop_back" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   (arg1)->pop_back();
@@ -14781,7 +14781,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::size_type arg2 ;
@@ -14794,12 +14794,12 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_resize__SWIG_0(PyObject *self, Py_ssize_
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_resize" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_resize" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_t_resize" "', argument " "2"" of type '" "std::vector< std::vector< int > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_T_resize" "', argument " "2"" of type '" "std::vector< std::vector< int > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< int > >::size_type >(val2);
   (arg1)->resize(arg2);
@@ -14810,7 +14810,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::iterator arg2 ;
@@ -14824,18 +14824,18 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_erase__SWIG_0(PyObject *self, Py_ssize_t
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_erase" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_erase" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t_erase" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T_erase" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t_erase" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T_erase" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
     }
   }
   result = std_vector_Sl_std_vector_Sl_int_Sg__Sg__erase__SWIG_0(arg1,SWIG_STD_MOVE(arg2));
@@ -14847,7 +14847,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::iterator arg2 ;
@@ -14864,29 +14864,29 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_erase__SWIG_1(PyObject *self, Py_ssize_t
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_erase" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_erase" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t_erase" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T_erase" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t_erase" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T_erase" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
     }
   }
   res3 = SWIG_ConvertPtr(swig_obj[2], SWIG_as_voidptrptr(&iter3), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res3) || !iter3) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t_erase" "', argument " "3"" of type '" "std::vector< std::vector< int > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T_erase" "', argument " "3"" of type '" "std::vector< std::vector< int > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *>(iter3);
     if (iter_t) {
       arg3 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t_erase" "', argument " "3"" of type '" "std::vector< std::vector< int > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T_erase" "', argument " "3"" of type '" "std::vector< std::vector< int > >::iterator""'");
     }
   }
   result = std_vector_Sl_std_vector_Sl_int_Sg__Sg__erase__SWIG_1(arg1,SWIG_STD_MOVE(arg2),SWIG_STD_MOVE(arg3));
@@ -14898,13 +14898,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_erase(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_erase(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_t_erase", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_T_erase", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -14915,7 +14915,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_erase(PyObject *self, PyObject *args) {
       int res = SWIG_ConvertPtr(argv[1], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
       _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *>(iter) != 0));
       if (_v) {
-        return _wrap_vinteger2d_t_erase__SWIG_0(self, argc, argv);
+        return _wrap_vinteger2d_T_erase__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -14932,14 +14932,14 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_erase(PyObject *self, PyObject *args) {
         int res = SWIG_ConvertPtr(argv[2], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
         _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *>(iter) != 0));
         if (_v) {
-          return _wrap_vinteger2d_t_erase__SWIG_1(self, argc, argv);
+          return _wrap_vinteger2d_T_erase__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_t_erase'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_T_erase'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< int > >::erase(std::vector< std::vector< int > >::iterator)\n"
     "    std::vector< std::vector< int > >::erase(std::vector< std::vector< int > >::iterator,std::vector< std::vector< int > >::iterator)\n");
@@ -14947,7 +14947,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vinteger2d_t__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vinteger2d_T__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > >::size_type arg1 ;
   std::vector< std::vector< int > >::value_type *arg2 = 0 ;
@@ -14960,17 +14960,17 @@ SWIGINTERN PyObject *_wrap_new_vinteger2d_t__SWIG_3(PyObject *self, Py_ssize_t n
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vinteger2d_t" "', argument " "1"" of type '" "std::vector< std::vector< int > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vinteger2d_T" "', argument " "1"" of type '" "std::vector< std::vector< int > >::size_type""'");
   } 
   arg1 = static_cast< std::vector< std::vector< int > >::size_type >(val1);
   {
     std::vector< int,std::allocator< int > > *ptr = (std::vector< int,std::allocator< int > > *)0;
     res2 = swig::asptr(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "new_vinteger2d_t" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "new_vinteger2d_T" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vinteger2d_t" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vinteger2d_T" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -14984,16 +14984,16 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vinteger2d_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_new_vinteger2d_T(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vinteger2d_t", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vinteger2d_T", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 0) {
-    return _wrap_new_vinteger2d_t__SWIG_0(self, argc, argv);
+    return _wrap_new_vinteger2d_T__SWIG_0(self, argc, argv);
   }
   if (argc == 1) {
     int _v = 0;
@@ -15002,7 +15002,7 @@ SWIGINTERN PyObject *_wrap_new_vinteger2d_t(PyObject *self, PyObject *args) {
       _v = SWIG_CheckState(res);
     }
     if (_v) {
-      return _wrap_new_vinteger2d_t__SWIG_2(self, argc, argv);
+      return _wrap_new_vinteger2d_T__SWIG_2(self, argc, argv);
     }
   }
   if (argc == 1) {
@@ -15010,7 +15010,7 @@ SWIGINTERN PyObject *_wrap_new_vinteger2d_t(PyObject *self, PyObject *args) {
     int res = swig::asptr(argv[0], (std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > >**)(0));
     _v = SWIG_CheckState(res);
     if (_v) {
-      return _wrap_new_vinteger2d_t__SWIG_1(self, argc, argv);
+      return _wrap_new_vinteger2d_T__SWIG_1(self, argc, argv);
     }
   }
   if (argc == 2) {
@@ -15023,13 +15023,13 @@ SWIGINTERN PyObject *_wrap_new_vinteger2d_t(PyObject *self, PyObject *args) {
       int res = swig::asptr(argv[1], (std::vector< int,std::allocator< int > >**)(0));
       _v = SWIG_CheckState(res);
       if (_v) {
-        return _wrap_new_vinteger2d_t__SWIG_3(self, argc, argv);
+        return _wrap_new_vinteger2d_T__SWIG_3(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vinteger2d_t'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vinteger2d_T'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< int > >::vector()\n"
     "    std::vector< std::vector< int > >::vector(std::vector< std::vector< int,std::allocator< int > > > const &)\n"
@@ -15039,7 +15039,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_push_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_push_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::value_type *arg2 = 0 ;
@@ -15049,20 +15049,20 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_push_back(PyObject *self, PyObject *args
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_t_push_back", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_T_push_back", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_push_back" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_push_back" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   {
     std::vector< int,std::allocator< int > > *ptr = (std::vector< int,std::allocator< int > > *)0;
     res2 = swig::asptr(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vinteger2d_t_push_back" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vinteger2d_T_push_back" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_t_push_back" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_T_push_back" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -15076,7 +15076,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_front(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_front(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -15089,7 +15089,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_front(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_front" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_front" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = (std::vector< std::vector< int > >::value_type *) &((std::vector< std::vector< int > > const *)arg1)->front();
@@ -15101,7 +15101,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -15114,7 +15114,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_back(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_back" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_back" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = (std::vector< std::vector< int > >::value_type *) &((std::vector< std::vector< int > > const *)arg1)->back();
@@ -15126,7 +15126,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_assign(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_assign(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::size_type arg2 ;
@@ -15139,25 +15139,25 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_assign(PyObject *self, PyObject *args) {
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_t_assign", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_T_assign", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_assign" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_assign" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_t_assign" "', argument " "2"" of type '" "std::vector< std::vector< int > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_T_assign" "', argument " "2"" of type '" "std::vector< std::vector< int > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< int > >::size_type >(val2);
   {
     std::vector< int,std::allocator< int > > *ptr = (std::vector< int,std::allocator< int > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vinteger2d_t_assign" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vinteger2d_T_assign" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_t_assign" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_T_assign" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -15171,7 +15171,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::size_type arg2 ;
@@ -15186,22 +15186,22 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_resize__SWIG_1(PyObject *self, Py_ssize_
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_resize" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_resize" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_t_resize" "', argument " "2"" of type '" "std::vector< std::vector< int > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_T_resize" "', argument " "2"" of type '" "std::vector< std::vector< int > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< int > >::size_type >(val2);
   {
     std::vector< int,std::allocator< int > > *ptr = (std::vector< int,std::allocator< int > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vinteger2d_t_resize" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vinteger2d_T_resize" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_t_resize" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_T_resize" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -15215,13 +15215,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_resize(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_resize(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_t_resize", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_T_resize", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -15233,7 +15233,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_resize(PyObject *self, PyObject *args) {
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vinteger2d_t_resize__SWIG_0(self, argc, argv);
+        return _wrap_vinteger2d_T_resize__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -15250,14 +15250,14 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_resize(PyObject *self, PyObject *args) {
         int res = swig::asptr(argv[2], (std::vector< int,std::allocator< int > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vinteger2d_t_resize__SWIG_1(self, argc, argv);
+          return _wrap_vinteger2d_T_resize__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_t_resize'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_T_resize'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< int > >::resize(std::vector< std::vector< int > >::size_type)\n"
     "    std::vector< std::vector< int > >::resize(std::vector< std::vector< int > >::size_type,std::vector< std::vector< int > >::value_type const &)\n");
@@ -15265,7 +15265,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::iterator arg2 ;
@@ -15281,28 +15281,28 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_insert__SWIG_0(PyObject *self, Py_ssize_
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_insert" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_insert" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t_insert" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T_insert" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t_insert" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T_insert" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
     }
   }
   {
     std::vector< int,std::allocator< int > > *ptr = (std::vector< int,std::allocator< int > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vinteger2d_t_insert" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vinteger2d_T_insert" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_t_insert" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_T_insert" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -15317,7 +15317,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::iterator arg2 ;
@@ -15335,33 +15335,33 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_insert__SWIG_1(PyObject *self, Py_ssize_
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_insert" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_insert" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t_insert" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T_insert" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t_insert" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T_insert" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_size_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vinteger2d_t_insert" "', argument " "3"" of type '" "std::vector< std::vector< int > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vinteger2d_T_insert" "', argument " "3"" of type '" "std::vector< std::vector< int > >::size_type""'");
   } 
   arg3 = static_cast< std::vector< std::vector< int > >::size_type >(val3);
   {
     std::vector< int,std::allocator< int > > *ptr = (std::vector< int,std::allocator< int > > *)0;
     res4 = swig::asptr(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vinteger2d_t_insert" "', argument " "4"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vinteger2d_T_insert" "', argument " "4"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_t_insert" "', argument " "4"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_T_insert" "', argument " "4"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     arg4 = ptr;
   }
@@ -15375,13 +15375,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_insert(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_insert(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_t_insert", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_T_insert", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -15395,7 +15395,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_insert(PyObject *self, PyObject *args) {
         int res = swig::asptr(argv[2], (std::vector< int,std::allocator< int > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vinteger2d_t_insert__SWIG_0(self, argc, argv);
+          return _wrap_vinteger2d_T_insert__SWIG_0(self, argc, argv);
         }
       }
     }
@@ -15417,7 +15417,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_insert(PyObject *self, PyObject *args) {
           int res = swig::asptr(argv[3], (std::vector< int,std::allocator< int > >**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vinteger2d_t_insert__SWIG_1(self, argc, argv);
+            return _wrap_vinteger2d_T_insert__SWIG_1(self, argc, argv);
           }
         }
       }
@@ -15425,7 +15425,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_insert(PyObject *self, PyObject *args) {
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_t_insert'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_T_insert'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< int > >::insert(std::vector< std::vector< int > >::iterator,std::vector< std::vector< int > >::value_type const &)\n"
     "    std::vector< std::vector< int > >::insert(std::vector< std::vector< int > >::iterator,std::vector< std::vector< int > >::size_type,std::vector< std::vector< int > >::value_type const &)\n");
@@ -15433,7 +15433,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_reserve(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_reserve(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::size_type arg2 ;
@@ -15444,15 +15444,15 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_reserve(PyObject *self, PyObject *args)
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_t_reserve", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_T_reserve", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_reserve" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_reserve" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_t_reserve" "', argument " "2"" of type '" "std::vector< std::vector< int > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_T_reserve" "', argument " "2"" of type '" "std::vector< std::vector< int > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< int > >::size_type >(val2);
   (arg1)->reserve(arg2);
@@ -15463,7 +15463,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_capacity(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_capacity(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -15476,7 +15476,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_capacity(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_capacity" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_capacity" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = ((std::vector< std::vector< int > > const *)arg1)->capacity();
@@ -15487,7 +15487,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_delete_vinteger2d_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_delete_vinteger2d_T(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -15499,7 +15499,7 @@ SWIGINTERN PyObject *_wrap_delete_vinteger2d_t(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, SWIG_POINTER_DISOWN |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vinteger2d_t" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vinteger2d_T" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   {
@@ -15520,18 +15520,18 @@ fail:
 }
 
 
-SWIGINTERN PyObject *vinteger2d_t_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vinteger2d_T_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   PyObject *obj;
   if (!SWIG_Python_UnpackTuple(args, "swigregister", 1, 1, &obj)) return NULL;
   SWIG_TypeNewClientData(SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, SWIG_NewClientData(obj));
   return SWIG_Py_Void();
 }
 
-SWIGINTERN PyObject *vinteger2d_t_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vinteger2d_T_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   return SWIG_Python_InitShadowInstance(args);
 }
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_iterator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_iterator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   PyObject **arg2 = (PyObject **) 0 ;
@@ -15546,7 +15546,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_iterator(PyObject *self, PyObjec
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_iterator" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_iterator" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = (swig::SwigPyIterator *)std_vector_Sl_unsigned_SS_long_Sg__iterator(arg1,arg2);
@@ -15557,7 +15557,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___nonzero__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___nonzero__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -15570,7 +15570,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___nonzero__(PyObject *self, PyOb
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___nonzero__" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___nonzero__" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = (bool)std_vector_Sl_unsigned_SS_long_Sg____nonzero__((std::vector< unsigned long > const *)arg1);
@@ -15581,7 +15581,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___bool__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___bool__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -15594,7 +15594,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___bool__(PyObject *self, PyObjec
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___bool__" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___bool__" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = (bool)std_vector_Sl_unsigned_SS_long_Sg____bool__((std::vector< unsigned long > const *)arg1);
@@ -15605,7 +15605,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___len__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___len__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -15618,7 +15618,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___len__(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___len__" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___len__" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = std_vector_Sl_unsigned_SS_long_Sg____len__((std::vector< unsigned long > const *)arg1);
@@ -15629,7 +15629,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___getslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___getslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::difference_type arg2 ;
@@ -15644,20 +15644,20 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___getslice__(PyObject *self, PyO
   std::vector< unsigned long,std::allocator< unsigned long > > *result = 0 ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_t___getslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_T___getslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___getslice__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___getslice__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t___getslice__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T___getslice__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< unsigned long >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_t___getslice__" "', argument " "3"" of type '" "std::vector< unsigned long >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_T___getslice__" "', argument " "3"" of type '" "std::vector< unsigned long >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< unsigned long >::difference_type >(val3);
   try {
@@ -15674,7 +15674,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::difference_type arg2 ;
@@ -15690,17 +15690,17 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setslice____SWIG_0(PyObject *s
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___setslice__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___setslice__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t___setslice__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T___setslice__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< unsigned long >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_t___setslice__" "', argument " "3"" of type '" "std::vector< unsigned long >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_T___setslice__" "', argument " "3"" of type '" "std::vector< unsigned long >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< unsigned long >::difference_type >(val3);
   try {
@@ -15717,7 +15717,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::difference_type arg2 ;
@@ -15735,27 +15735,27 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setslice____SWIG_1(PyObject *s
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___setslice__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___setslice__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t___setslice__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T___setslice__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< unsigned long >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_t___setslice__" "', argument " "3"" of type '" "std::vector< unsigned long >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_T___setslice__" "', argument " "3"" of type '" "std::vector< unsigned long >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< unsigned long >::difference_type >(val3);
   {
     std::vector< unsigned long,std::allocator< unsigned long > > *ptr = (std::vector< unsigned long,std::allocator< unsigned long > > *)0;
     res4 = swig::asptr(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_longinteger_t___setslice__" "', argument " "4"" of type '" "std::vector< unsigned long,std::allocator< unsigned long > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_longinteger_T___setslice__" "', argument " "4"" of type '" "std::vector< unsigned long,std::allocator< unsigned long > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_longinteger_t___setslice__" "', argument " "4"" of type '" "std::vector< unsigned long,std::allocator< unsigned long > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_longinteger_T___setslice__" "', argument " "4"" of type '" "std::vector< unsigned long,std::allocator< unsigned long > > const &""'"); 
     }
     arg4 = ptr;
   }
@@ -15775,13 +15775,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___setslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___setslice__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_t___setslice__", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_T___setslice__", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -15798,7 +15798,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setslice__(PyObject *self, PyO
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_longinteger_t___setslice____SWIG_0(self, argc, argv);
+          return _wrap_vector_longinteger_T___setslice____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -15821,7 +15821,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setslice__(PyObject *self, PyO
           int res = swig::asptr(argv[3], (std::vector< unsigned long,std::allocator< unsigned long > >**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vector_longinteger_t___setslice____SWIG_1(self, argc, argv);
+            return _wrap_vector_longinteger_T___setslice____SWIG_1(self, argc, argv);
           }
         }
       }
@@ -15829,7 +15829,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setslice__(PyObject *self, PyO
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_t___setslice__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_T___setslice__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< unsigned long >::__setslice__(std::vector< unsigned long >::difference_type,std::vector< unsigned long >::difference_type)\n"
     "    std::vector< unsigned long >::__setslice__(std::vector< unsigned long >::difference_type,std::vector< unsigned long >::difference_type,std::vector< unsigned long,std::allocator< unsigned long > > const &)\n");
@@ -15837,7 +15837,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___delslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___delslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::difference_type arg2 ;
@@ -15851,20 +15851,20 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___delslice__(PyObject *self, PyO
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_t___delslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_T___delslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___delslice__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___delslice__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t___delslice__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T___delslice__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< unsigned long >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_t___delslice__" "', argument " "3"" of type '" "std::vector< unsigned long >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_T___delslice__" "', argument " "3"" of type '" "std::vector< unsigned long >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< unsigned long >::difference_type >(val3);
   try {
@@ -15881,7 +15881,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::difference_type arg2 ;
@@ -15894,12 +15894,12 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___delitem____SWIG_0(PyObject *se
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___delitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___delitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t___delitem__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T___delitem__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< unsigned long >::difference_type >(val2);
   try {
@@ -15916,7 +15916,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -15928,12 +15928,12 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___getitem____SWIG_0(PyObject *se
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___getitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___getitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -15951,7 +15951,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -15964,12 +15964,12 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setitem____SWIG_0(PyObject *se
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___setitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___setitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -15977,10 +15977,10 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setitem____SWIG_0(PyObject *se
     std::vector< unsigned long,std::allocator< unsigned long > > *ptr = (std::vector< unsigned long,std::allocator< unsigned long > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_longinteger_t___setitem__" "', argument " "3"" of type '" "std::vector< unsigned long,std::allocator< unsigned long > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_longinteger_T___setitem__" "', argument " "3"" of type '" "std::vector< unsigned long,std::allocator< unsigned long > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_longinteger_t___setitem__" "', argument " "3"" of type '" "std::vector< unsigned long,std::allocator< unsigned long > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_longinteger_T___setitem__" "', argument " "3"" of type '" "std::vector< unsigned long,std::allocator< unsigned long > > const &""'"); 
     }
     arg3 = ptr;
   }
@@ -16000,7 +16000,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -16011,12 +16011,12 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setitem____SWIG_1(PyObject *se
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___setitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___setitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -16034,7 +16034,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -16045,12 +16045,12 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___delitem____SWIG_1(PyObject *se
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___delitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___delitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -16068,13 +16068,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___delitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___delitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_t___delitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_T___delitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -16085,7 +16085,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___delitem__(PyObject *self, PyOb
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_longinteger_t___delitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_longinteger_T___delitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -16099,13 +16099,13 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___delitem__(PyObject *self, PyOb
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_longinteger_t___delitem____SWIG_0(self, argc, argv);
+        return _wrap_vector_longinteger_T___delitem____SWIG_0(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_t___delitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_T___delitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< unsigned long >::__delitem__(std::vector< unsigned long >::difference_type)\n"
     "    std::vector< unsigned long >::__delitem__(SWIGPY_SLICEOBJECT *)\n");
@@ -16113,7 +16113,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::difference_type arg2 ;
@@ -16127,12 +16127,12 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___getitem____SWIG_1(PyObject *se
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___getitem__" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___getitem__" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t___getitem__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T___getitem__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< unsigned long >::difference_type >(val2);
   try {
@@ -16148,13 +16148,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___getitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___getitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_t___getitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_T___getitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -16165,7 +16165,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___getitem__(PyObject *self, PyOb
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_longinteger_t___getitem____SWIG_0(self, argc, argv);
+        return _wrap_vector_longinteger_T___getitem____SWIG_0(self, argc, argv);
       }
     }
   }
@@ -16179,13 +16179,13 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___getitem__(PyObject *self, PyOb
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_longinteger_t___getitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_longinteger_T___getitem____SWIG_1(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_t___getitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_T___getitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< unsigned long >::__getitem__(SWIGPY_SLICEOBJECT *)\n"
     "    std::vector< unsigned long >::__getitem__(std::vector< unsigned long >::difference_type) const\n");
@@ -16193,7 +16193,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::difference_type arg2 ;
@@ -16210,17 +16210,17 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setitem____SWIG_2(PyObject *se
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___setitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___setitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t___setitem__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T___setitem__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< unsigned long >::difference_type >(val2);
   ecode3 = SWIG_AsVal_unsigned_SS_long(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_t___setitem__" "', argument " "3"" of type '" "std::vector< unsigned long >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_T___setitem__" "', argument " "3"" of type '" "std::vector< unsigned long >::value_type""'");
   } 
   temp3 = static_cast< std::vector< unsigned long >::value_type >(val3);
   arg3 = &temp3;
@@ -16236,13 +16236,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___setitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___setitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_t___setitem__", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_T___setitem__", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -16253,7 +16253,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setitem__(PyObject *self, PyOb
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_longinteger_t___setitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_longinteger_T___setitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -16269,7 +16269,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setitem__(PyObject *self, PyOb
         int res = swig::asptr(argv[2], (std::vector< unsigned long,std::allocator< unsigned long > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vector_longinteger_t___setitem____SWIG_0(self, argc, argv);
+          return _wrap_vector_longinteger_T___setitem____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -16289,14 +16289,14 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setitem__(PyObject *self, PyOb
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_longinteger_t___setitem____SWIG_2(self, argc, argv);
+          return _wrap_vector_longinteger_T___setitem____SWIG_2(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_t___setitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_T___setitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< unsigned long >::__setitem__(SWIGPY_SLICEOBJECT *,std::vector< unsigned long,std::allocator< unsigned long > > const &)\n"
     "    std::vector< unsigned long >::__setitem__(SWIGPY_SLICEOBJECT *)\n"
@@ -16305,7 +16305,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_pop(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_pop(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -16318,7 +16318,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_pop(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_pop" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_pop" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   try {
@@ -16333,7 +16333,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_append(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_append(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::value_type *arg2 = 0 ;
@@ -16345,15 +16345,15 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_append(PyObject *self, PyObject
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_t_append", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_T_append", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_append" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_append" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_unsigned_SS_long(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t_append" "', argument " "2"" of type '" "std::vector< unsigned long >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T_append" "', argument " "2"" of type '" "std::vector< unsigned long >::value_type""'");
   } 
   temp2 = static_cast< std::vector< unsigned long >::value_type >(val2);
   arg2 = &temp2;
@@ -16365,7 +16365,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_longinteger_t__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
+SWIGINTERN PyObject *_wrap_new_vector_longinteger_T__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *result = 0 ;
   
@@ -16379,7 +16379,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_longinteger_t__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_longinteger_T__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = 0 ;
   int res1 = SWIG_OLDOBJ ;
@@ -16391,10 +16391,10 @@ SWIGINTERN PyObject *_wrap_new_vector_longinteger_t__SWIG_1(PyObject *self, Py_s
     std::vector< unsigned long,std::allocator< unsigned long > > *ptr = (std::vector< unsigned long,std::allocator< unsigned long > > *)0;
     res1 = swig::asptr(swig_obj[0], &ptr);
     if (!SWIG_IsOK(res1)) {
-      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vector_longinteger_t" "', argument " "1"" of type '" "std::vector< unsigned long > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vector_longinteger_T" "', argument " "1"" of type '" "std::vector< unsigned long > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_longinteger_t" "', argument " "1"" of type '" "std::vector< unsigned long > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_longinteger_T" "', argument " "1"" of type '" "std::vector< unsigned long > const &""'"); 
     }
     arg1 = ptr;
   }
@@ -16408,7 +16408,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_empty(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_empty(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -16421,7 +16421,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_empty(PyObject *self, PyObject *
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_empty" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_empty" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = (bool)((std::vector< unsigned long > const *)arg1)->empty();
@@ -16432,7 +16432,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_size(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_size(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -16445,7 +16445,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_size(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_size" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_size" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = ((std::vector< unsigned long > const *)arg1)->size();
@@ -16456,7 +16456,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_swap(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_swap(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long > *arg2 = 0 ;
@@ -16467,18 +16467,18 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_swap(PyObject *self, PyObject *a
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_t_swap", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_T_swap", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_swap" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_swap" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], &argp2, SWIGTYPE_p_std__vectorT_unsigned_long_t,  0 );
   if (!SWIG_IsOK(res2)) {
-    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_longinteger_t_swap" "', argument " "2"" of type '" "std::vector< unsigned long > &""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_longinteger_T_swap" "', argument " "2"" of type '" "std::vector< unsigned long > &""'"); 
   }
   if (!argp2) {
-    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_longinteger_t_swap" "', argument " "2"" of type '" "std::vector< unsigned long > &""'"); 
+    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_longinteger_T_swap" "', argument " "2"" of type '" "std::vector< unsigned long > &""'"); 
   }
   arg2 = reinterpret_cast< std::vector< unsigned long > * >(argp2);
   (arg1)->swap(*arg2);
@@ -16489,7 +16489,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_begin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_begin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -16502,7 +16502,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_begin(PyObject *self, PyObject *
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_begin" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_begin" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = (arg1)->begin();
@@ -16514,7 +16514,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_end(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_end(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -16527,7 +16527,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_end(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_end" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_end" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = (arg1)->end();
@@ -16539,7 +16539,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_rbegin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_rbegin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -16552,7 +16552,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_rbegin(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_rbegin" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_rbegin" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = (arg1)->rbegin();
@@ -16564,7 +16564,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_rend(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_rend(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -16577,7 +16577,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_rend(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_rend" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_rend" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = (arg1)->rend();
@@ -16589,7 +16589,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_clear(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_clear(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -16601,7 +16601,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_clear(PyObject *self, PyObject *
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_clear" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_clear" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   (arg1)->clear();
@@ -16612,7 +16612,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_get_allocator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_get_allocator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -16625,7 +16625,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_get_allocator(PyObject *self, Py
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_get_allocator" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_get_allocator" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = ((std::vector< unsigned long > const *)arg1)->get_allocator();
@@ -16636,7 +16636,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_longinteger_t__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_longinteger_T__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long >::size_type arg1 ;
   size_t val1 ;
@@ -16647,7 +16647,7 @@ SWIGINTERN PyObject *_wrap_new_vector_longinteger_t__SWIG_2(PyObject *self, Py_s
   if ((nobjs < 1) || (nobjs > 1)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_longinteger_t" "', argument " "1"" of type '" "std::vector< unsigned long >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_longinteger_T" "', argument " "1"" of type '" "std::vector< unsigned long >::size_type""'");
   } 
   arg1 = static_cast< std::vector< unsigned long >::size_type >(val1);
   result = (std::vector< unsigned long > *)new std::vector< unsigned long >(arg1);
@@ -16658,7 +16658,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_pop_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_pop_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -16670,7 +16670,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_pop_back(PyObject *self, PyObjec
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_pop_back" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_pop_back" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   (arg1)->pop_back();
@@ -16681,7 +16681,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::size_type arg2 ;
@@ -16694,12 +16694,12 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_resize__SWIG_0(PyObject *self, P
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_resize" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_resize" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t_resize" "', argument " "2"" of type '" "std::vector< unsigned long >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T_resize" "', argument " "2"" of type '" "std::vector< unsigned long >::size_type""'");
   } 
   arg2 = static_cast< std::vector< unsigned long >::size_type >(val2);
   (arg1)->resize(arg2);
@@ -16710,7 +16710,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::iterator arg2 ;
@@ -16724,18 +16724,18 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_erase__SWIG_0(PyObject *self, Py
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_erase" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_erase" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t_erase" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T_erase" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t_erase" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T_erase" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
     }
   }
   result = std_vector_Sl_unsigned_SS_long_Sg__erase__SWIG_0(arg1,SWIG_STD_MOVE(arg2));
@@ -16747,7 +16747,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::iterator arg2 ;
@@ -16764,29 +16764,29 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_erase__SWIG_1(PyObject *self, Py
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_erase" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_erase" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t_erase" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T_erase" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t_erase" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T_erase" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
     }
   }
   res3 = SWIG_ConvertPtr(swig_obj[2], SWIG_as_voidptrptr(&iter3), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res3) || !iter3) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t_erase" "', argument " "3"" of type '" "std::vector< unsigned long >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T_erase" "', argument " "3"" of type '" "std::vector< unsigned long >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *>(iter3);
     if (iter_t) {
       arg3 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t_erase" "', argument " "3"" of type '" "std::vector< unsigned long >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T_erase" "', argument " "3"" of type '" "std::vector< unsigned long >::iterator""'");
     }
   }
   result = std_vector_Sl_unsigned_SS_long_Sg__erase__SWIG_1(arg1,SWIG_STD_MOVE(arg2),SWIG_STD_MOVE(arg3));
@@ -16798,13 +16798,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_erase(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_erase(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_t_erase", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_T_erase", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -16815,7 +16815,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_erase(PyObject *self, PyObject *
       int res = SWIG_ConvertPtr(argv[1], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
       _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *>(iter) != 0));
       if (_v) {
-        return _wrap_vector_longinteger_t_erase__SWIG_0(self, argc, argv);
+        return _wrap_vector_longinteger_T_erase__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -16832,14 +16832,14 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_erase(PyObject *self, PyObject *
         int res = SWIG_ConvertPtr(argv[2], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
         _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *>(iter) != 0));
         if (_v) {
-          return _wrap_vector_longinteger_t_erase__SWIG_1(self, argc, argv);
+          return _wrap_vector_longinteger_T_erase__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_t_erase'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_T_erase'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< unsigned long >::erase(std::vector< unsigned long >::iterator)\n"
     "    std::vector< unsigned long >::erase(std::vector< unsigned long >::iterator,std::vector< unsigned long >::iterator)\n");
@@ -16847,7 +16847,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_longinteger_t__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_longinteger_T__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long >::size_type arg1 ;
   std::vector< unsigned long >::value_type *arg2 = 0 ;
@@ -16862,12 +16862,12 @@ SWIGINTERN PyObject *_wrap_new_vector_longinteger_t__SWIG_3(PyObject *self, Py_s
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_longinteger_t" "', argument " "1"" of type '" "std::vector< unsigned long >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_longinteger_T" "', argument " "1"" of type '" "std::vector< unsigned long >::size_type""'");
   } 
   arg1 = static_cast< std::vector< unsigned long >::size_type >(val1);
   ecode2 = SWIG_AsVal_unsigned_SS_long(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "new_vector_longinteger_t" "', argument " "2"" of type '" "std::vector< unsigned long >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "new_vector_longinteger_T" "', argument " "2"" of type '" "std::vector< unsigned long >::value_type""'");
   } 
   temp2 = static_cast< std::vector< unsigned long >::value_type >(val2);
   arg2 = &temp2;
@@ -16879,16 +16879,16 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_longinteger_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_new_vector_longinteger_T(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vector_longinteger_t", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vector_longinteger_T", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 0) {
-    return _wrap_new_vector_longinteger_t__SWIG_0(self, argc, argv);
+    return _wrap_new_vector_longinteger_T__SWIG_0(self, argc, argv);
   }
   if (argc == 1) {
     int _v = 0;
@@ -16897,7 +16897,7 @@ SWIGINTERN PyObject *_wrap_new_vector_longinteger_t(PyObject *self, PyObject *ar
       _v = SWIG_CheckState(res);
     }
     if (_v) {
-      return _wrap_new_vector_longinteger_t__SWIG_2(self, argc, argv);
+      return _wrap_new_vector_longinteger_T__SWIG_2(self, argc, argv);
     }
   }
   if (argc == 1) {
@@ -16905,7 +16905,7 @@ SWIGINTERN PyObject *_wrap_new_vector_longinteger_t(PyObject *self, PyObject *ar
     int res = swig::asptr(argv[0], (std::vector< unsigned long,std::allocator< unsigned long > >**)(0));
     _v = SWIG_CheckState(res);
     if (_v) {
-      return _wrap_new_vector_longinteger_t__SWIG_1(self, argc, argv);
+      return _wrap_new_vector_longinteger_T__SWIG_1(self, argc, argv);
     }
   }
   if (argc == 2) {
@@ -16920,13 +16920,13 @@ SWIGINTERN PyObject *_wrap_new_vector_longinteger_t(PyObject *self, PyObject *ar
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_new_vector_longinteger_t__SWIG_3(self, argc, argv);
+        return _wrap_new_vector_longinteger_T__SWIG_3(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vector_longinteger_t'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vector_longinteger_T'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< unsigned long >::vector()\n"
     "    std::vector< unsigned long >::vector(std::vector< unsigned long > const &)\n"
@@ -16936,7 +16936,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_push_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_push_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::value_type *arg2 = 0 ;
@@ -16948,15 +16948,15 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_push_back(PyObject *self, PyObje
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_t_push_back", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_T_push_back", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_push_back" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_push_back" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_unsigned_SS_long(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t_push_back" "', argument " "2"" of type '" "std::vector< unsigned long >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T_push_back" "', argument " "2"" of type '" "std::vector< unsigned long >::value_type""'");
   } 
   temp2 = static_cast< std::vector< unsigned long >::value_type >(val2);
   arg2 = &temp2;
@@ -16968,7 +16968,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_front(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_front(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -16981,7 +16981,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_front(PyObject *self, PyObject *
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_front" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_front" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = (std::vector< unsigned long >::value_type *) &((std::vector< unsigned long > const *)arg1)->front();
@@ -16993,7 +16993,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -17006,7 +17006,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_back(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_back" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_back" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = (std::vector< unsigned long >::value_type *) &((std::vector< unsigned long > const *)arg1)->back();
@@ -17018,7 +17018,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_assign(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_assign(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::size_type arg2 ;
@@ -17033,20 +17033,20 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_assign(PyObject *self, PyObject
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_t_assign", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_T_assign", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_assign" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_assign" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t_assign" "', argument " "2"" of type '" "std::vector< unsigned long >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T_assign" "', argument " "2"" of type '" "std::vector< unsigned long >::size_type""'");
   } 
   arg2 = static_cast< std::vector< unsigned long >::size_type >(val2);
   ecode3 = SWIG_AsVal_unsigned_SS_long(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_t_assign" "', argument " "3"" of type '" "std::vector< unsigned long >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_T_assign" "', argument " "3"" of type '" "std::vector< unsigned long >::value_type""'");
   } 
   temp3 = static_cast< std::vector< unsigned long >::value_type >(val3);
   arg3 = &temp3;
@@ -17058,7 +17058,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::size_type arg2 ;
@@ -17075,17 +17075,17 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_resize__SWIG_1(PyObject *self, P
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_resize" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_resize" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t_resize" "', argument " "2"" of type '" "std::vector< unsigned long >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T_resize" "', argument " "2"" of type '" "std::vector< unsigned long >::size_type""'");
   } 
   arg2 = static_cast< std::vector< unsigned long >::size_type >(val2);
   ecode3 = SWIG_AsVal_unsigned_SS_long(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_t_resize" "', argument " "3"" of type '" "std::vector< unsigned long >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_T_resize" "', argument " "3"" of type '" "std::vector< unsigned long >::value_type""'");
   } 
   temp3 = static_cast< std::vector< unsigned long >::value_type >(val3);
   arg3 = &temp3;
@@ -17097,13 +17097,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_resize(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_resize(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_t_resize", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_T_resize", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -17115,7 +17115,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_resize(PyObject *self, PyObject
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_longinteger_t_resize__SWIG_0(self, argc, argv);
+        return _wrap_vector_longinteger_T_resize__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -17134,14 +17134,14 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_resize(PyObject *self, PyObject
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_longinteger_t_resize__SWIG_1(self, argc, argv);
+          return _wrap_vector_longinteger_T_resize__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_t_resize'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_T_resize'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< unsigned long >::resize(std::vector< unsigned long >::size_type)\n"
     "    std::vector< unsigned long >::resize(std::vector< unsigned long >::size_type,std::vector< unsigned long >::value_type const &)\n");
@@ -17149,7 +17149,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::iterator arg2 ;
@@ -17167,23 +17167,23 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_insert__SWIG_0(PyObject *self, P
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_insert" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_insert" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t_insert" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T_insert" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t_insert" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T_insert" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_unsigned_SS_long(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_t_insert" "', argument " "3"" of type '" "std::vector< unsigned long >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_T_insert" "', argument " "3"" of type '" "std::vector< unsigned long >::value_type""'");
   } 
   temp3 = static_cast< std::vector< unsigned long >::value_type >(val3);
   arg3 = &temp3;
@@ -17196,7 +17196,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::iterator arg2 ;
@@ -17216,28 +17216,28 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_insert__SWIG_1(PyObject *self, P
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_insert" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_insert" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t_insert" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T_insert" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t_insert" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T_insert" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_size_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_t_insert" "', argument " "3"" of type '" "std::vector< unsigned long >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_T_insert" "', argument " "3"" of type '" "std::vector< unsigned long >::size_type""'");
   } 
   arg3 = static_cast< std::vector< unsigned long >::size_type >(val3);
   ecode4 = SWIG_AsVal_unsigned_SS_long(swig_obj[3], &val4);
   if (!SWIG_IsOK(ecode4)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode4), "in method '" "vector_longinteger_t_insert" "', argument " "4"" of type '" "std::vector< unsigned long >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode4), "in method '" "vector_longinteger_T_insert" "', argument " "4"" of type '" "std::vector< unsigned long >::value_type""'");
   } 
   temp4 = static_cast< std::vector< unsigned long >::value_type >(val4);
   arg4 = &temp4;
@@ -17249,13 +17249,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_insert(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_insert(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_t_insert", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_T_insert", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -17271,7 +17271,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_insert(PyObject *self, PyObject
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_longinteger_t_insert__SWIG_0(self, argc, argv);
+          return _wrap_vector_longinteger_T_insert__SWIG_0(self, argc, argv);
         }
       }
     }
@@ -17295,7 +17295,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_insert(PyObject *self, PyObject
             _v = SWIG_CheckState(res);
           }
           if (_v) {
-            return _wrap_vector_longinteger_t_insert__SWIG_1(self, argc, argv);
+            return _wrap_vector_longinteger_T_insert__SWIG_1(self, argc, argv);
           }
         }
       }
@@ -17303,7 +17303,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_insert(PyObject *self, PyObject
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_t_insert'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_T_insert'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< unsigned long >::insert(std::vector< unsigned long >::iterator,std::vector< unsigned long >::value_type const &)\n"
     "    std::vector< unsigned long >::insert(std::vector< unsigned long >::iterator,std::vector< unsigned long >::size_type,std::vector< unsigned long >::value_type const &)\n");
@@ -17311,7 +17311,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_reserve(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_reserve(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::size_type arg2 ;
@@ -17322,15 +17322,15 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_reserve(PyObject *self, PyObject
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_t_reserve", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_T_reserve", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_reserve" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_reserve" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t_reserve" "', argument " "2"" of type '" "std::vector< unsigned long >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T_reserve" "', argument " "2"" of type '" "std::vector< unsigned long >::size_type""'");
   } 
   arg2 = static_cast< std::vector< unsigned long >::size_type >(val2);
   (arg1)->reserve(arg2);
@@ -17341,7 +17341,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_capacity(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_capacity(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -17354,7 +17354,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_capacity(PyObject *self, PyObjec
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_capacity" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_capacity" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = ((std::vector< unsigned long > const *)arg1)->capacity();
@@ -17365,7 +17365,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_delete_vector_longinteger_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_delete_vector_longinteger_T(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -17377,7 +17377,7 @@ SWIGINTERN PyObject *_wrap_delete_vector_longinteger_t(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, SWIG_POINTER_DISOWN |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vector_longinteger_t" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vector_longinteger_T" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   {
@@ -17398,18 +17398,18 @@ fail:
 }
 
 
-SWIGINTERN PyObject *vector_longinteger_t_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vector_longinteger_T_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   PyObject *obj;
   if (!SWIG_Python_UnpackTuple(args, "swigregister", 1, 1, &obj)) return NULL;
   SWIG_TypeNewClientData(SWIGTYPE_p_std__vectorT_unsigned_long_t, SWIG_NewClientData(obj));
   return SWIG_Py_Void();
 }
 
-SWIGINTERN PyObject *vector_longinteger_t_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vector_longinteger_T_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   return SWIG_Python_InitShadowInstance(args);
 }
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_iterator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_iterator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   PyObject **arg2 = (PyObject **) 0 ;
@@ -17424,7 +17424,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_iterator(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_iterator" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_iterator" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = (swig::SwigPyIterator *)std_vector_Sl_std_complex_Sl_double_Sg__Sg__iterator(arg1,arg2);
@@ -17435,7 +17435,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___nonzero__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___nonzero__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -17448,7 +17448,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___nonzero__(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___nonzero__" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___nonzero__" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = (bool)std_vector_Sl_std_complex_Sl_double_Sg__Sg____nonzero__((std::vector< std::complex< double > > const *)arg1);
@@ -17459,7 +17459,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___bool__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___bool__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -17472,7 +17472,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___bool__(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___bool__" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___bool__" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = (bool)std_vector_Sl_std_complex_Sl_double_Sg__Sg____bool__((std::vector< std::complex< double > > const *)arg1);
@@ -17483,7 +17483,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___len__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___len__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -17496,7 +17496,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___len__(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___len__" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___len__" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = std_vector_Sl_std_complex_Sl_double_Sg__Sg____len__((std::vector< std::complex< double > > const *)arg1);
@@ -17507,7 +17507,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___getslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___getslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::difference_type arg2 ;
@@ -17522,20 +17522,20 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___getslice__(PyObject *self, PyObjec
   std::vector< std::complex< double >,std::allocator< std::complex< double > > > *result = 0 ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_complex_t___getslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_complex_T___getslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___getslice__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___getslice__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t___getslice__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T___getslice__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::complex< double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_t___getslice__" "', argument " "3"" of type '" "std::vector< std::complex< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_T___getslice__" "', argument " "3"" of type '" "std::vector< std::complex< double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::complex< double > >::difference_type >(val3);
   try {
@@ -17552,7 +17552,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::difference_type arg2 ;
@@ -17568,17 +17568,17 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setslice____SWIG_0(PyObject *self,
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___setslice__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___setslice__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t___setslice__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T___setslice__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::complex< double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_t___setslice__" "', argument " "3"" of type '" "std::vector< std::complex< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_T___setslice__" "', argument " "3"" of type '" "std::vector< std::complex< double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::complex< double > >::difference_type >(val3);
   try {
@@ -17595,7 +17595,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::difference_type arg2 ;
@@ -17613,27 +17613,27 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setslice____SWIG_1(PyObject *self,
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___setslice__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___setslice__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t___setslice__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T___setslice__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::complex< double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_t___setslice__" "', argument " "3"" of type '" "std::vector< std::complex< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_T___setslice__" "', argument " "3"" of type '" "std::vector< std::complex< double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::complex< double > >::difference_type >(val3);
   {
     std::vector< std::complex< double >,std::allocator< std::complex< double > > > *ptr = (std::vector< std::complex< double >,std::allocator< std::complex< double > > > *)0;
     res4 = swig::asptr(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_complex_t___setslice__" "', argument " "4"" of type '" "std::vector< std::complex< double >,std::allocator< std::complex< double > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_complex_T___setslice__" "', argument " "4"" of type '" "std::vector< std::complex< double >,std::allocator< std::complex< double > > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_complex_t___setslice__" "', argument " "4"" of type '" "std::vector< std::complex< double >,std::allocator< std::complex< double > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_complex_T___setslice__" "', argument " "4"" of type '" "std::vector< std::complex< double >,std::allocator< std::complex< double > > > const &""'"); 
     }
     arg4 = ptr;
   }
@@ -17653,13 +17653,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___setslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___setslice__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_t___setslice__", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_T___setslice__", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -17676,7 +17676,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setslice__(PyObject *self, PyObjec
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_complex_t___setslice____SWIG_0(self, argc, argv);
+          return _wrap_vector_complex_T___setslice____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -17699,7 +17699,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setslice__(PyObject *self, PyObjec
           int res = swig::asptr(argv[3], (std::vector< std::complex< double >,std::allocator< std::complex< double > > >**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vector_complex_t___setslice____SWIG_1(self, argc, argv);
+            return _wrap_vector_complex_T___setslice____SWIG_1(self, argc, argv);
           }
         }
       }
@@ -17707,7 +17707,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setslice__(PyObject *self, PyObjec
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_t___setslice__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_T___setslice__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::complex< double > >::__setslice__(std::vector< std::complex< double > >::difference_type,std::vector< std::complex< double > >::difference_type)\n"
     "    std::vector< std::complex< double > >::__setslice__(std::vector< std::complex< double > >::difference_type,std::vector< std::complex< double > >::difference_type,std::vector< std::complex< double >,std::allocator< std::complex< double > > > const &)\n");
@@ -17715,7 +17715,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___delslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___delslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::difference_type arg2 ;
@@ -17729,20 +17729,20 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___delslice__(PyObject *self, PyObjec
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_complex_t___delslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_complex_T___delslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___delslice__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___delslice__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t___delslice__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T___delslice__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::complex< double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_t___delslice__" "', argument " "3"" of type '" "std::vector< std::complex< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_T___delslice__" "', argument " "3"" of type '" "std::vector< std::complex< double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::complex< double > >::difference_type >(val3);
   try {
@@ -17759,7 +17759,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::difference_type arg2 ;
@@ -17772,12 +17772,12 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___delitem____SWIG_0(PyObject *self,
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___delitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___delitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t___delitem__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T___delitem__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::complex< double > >::difference_type >(val2);
   try {
@@ -17794,7 +17794,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -17806,12 +17806,12 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___getitem____SWIG_0(PyObject *self,
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___getitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___getitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -17829,7 +17829,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -17842,12 +17842,12 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setitem____SWIG_0(PyObject *self,
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___setitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___setitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -17855,10 +17855,10 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setitem____SWIG_0(PyObject *self,
     std::vector< std::complex< double >,std::allocator< std::complex< double > > > *ptr = (std::vector< std::complex< double >,std::allocator< std::complex< double > > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_complex_t___setitem__" "', argument " "3"" of type '" "std::vector< std::complex< double >,std::allocator< std::complex< double > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_complex_T___setitem__" "', argument " "3"" of type '" "std::vector< std::complex< double >,std::allocator< std::complex< double > > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_complex_t___setitem__" "', argument " "3"" of type '" "std::vector< std::complex< double >,std::allocator< std::complex< double > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_complex_T___setitem__" "', argument " "3"" of type '" "std::vector< std::complex< double >,std::allocator< std::complex< double > > > const &""'"); 
     }
     arg3 = ptr;
   }
@@ -17878,7 +17878,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -17889,12 +17889,12 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setitem____SWIG_1(PyObject *self,
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___setitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___setitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -17912,7 +17912,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -17923,12 +17923,12 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___delitem____SWIG_1(PyObject *self,
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___delitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___delitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -17946,13 +17946,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___delitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___delitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_t___delitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_T___delitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -17963,7 +17963,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___delitem__(PyObject *self, PyObject
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_complex_t___delitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_complex_T___delitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -17977,13 +17977,13 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___delitem__(PyObject *self, PyObject
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_complex_t___delitem____SWIG_0(self, argc, argv);
+        return _wrap_vector_complex_T___delitem____SWIG_0(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_t___delitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_T___delitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::complex< double > >::__delitem__(std::vector< std::complex< double > >::difference_type)\n"
     "    std::vector< std::complex< double > >::__delitem__(SWIGPY_SLICEOBJECT *)\n");
@@ -17991,7 +17991,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::difference_type arg2 ;
@@ -18005,12 +18005,12 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___getitem____SWIG_1(PyObject *self,
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___getitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___getitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t___getitem__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T___getitem__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::complex< double > >::difference_type >(val2);
   try {
@@ -18026,13 +18026,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___getitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___getitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_t___getitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_T___getitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -18043,7 +18043,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___getitem__(PyObject *self, PyObject
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_complex_t___getitem____SWIG_0(self, argc, argv);
+        return _wrap_vector_complex_T___getitem____SWIG_0(self, argc, argv);
       }
     }
   }
@@ -18057,13 +18057,13 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___getitem__(PyObject *self, PyObject
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_complex_t___getitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_complex_T___getitem____SWIG_1(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_t___getitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_T___getitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::complex< double > >::__getitem__(SWIGPY_SLICEOBJECT *)\n"
     "    std::vector< std::complex< double > >::__getitem__(std::vector< std::complex< double > >::difference_type) const\n");
@@ -18071,7 +18071,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::difference_type arg2 ;
@@ -18088,17 +18088,17 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setitem____SWIG_2(PyObject *self,
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___setitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___setitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t___setitem__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T___setitem__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::complex< double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_std_complex_Sl_double_Sg_(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_t___setitem__" "', argument " "3"" of type '" "std::vector< std::complex< double > >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_T___setitem__" "', argument " "3"" of type '" "std::vector< std::complex< double > >::value_type""'");
   } 
   temp3 = static_cast< std::vector< std::complex< double > >::value_type >(val3);
   arg3 = &temp3;
@@ -18114,13 +18114,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___setitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___setitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_t___setitem__", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_T___setitem__", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -18131,7 +18131,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setitem__(PyObject *self, PyObject
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_complex_t___setitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_complex_T___setitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -18147,7 +18147,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setitem__(PyObject *self, PyObject
         int res = swig::asptr(argv[2], (std::vector< std::complex< double >,std::allocator< std::complex< double > > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vector_complex_t___setitem____SWIG_0(self, argc, argv);
+          return _wrap_vector_complex_T___setitem____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -18167,14 +18167,14 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setitem__(PyObject *self, PyObject
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_complex_t___setitem____SWIG_2(self, argc, argv);
+          return _wrap_vector_complex_T___setitem____SWIG_2(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_t___setitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_T___setitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::complex< double > >::__setitem__(SWIGPY_SLICEOBJECT *,std::vector< std::complex< double >,std::allocator< std::complex< double > > > const &)\n"
     "    std::vector< std::complex< double > >::__setitem__(SWIGPY_SLICEOBJECT *)\n"
@@ -18183,7 +18183,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_pop(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_pop(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -18196,7 +18196,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_pop(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_pop" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_pop" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   try {
@@ -18211,7 +18211,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_append(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_append(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::value_type *arg2 = 0 ;
@@ -18223,15 +18223,15 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_append(PyObject *self, PyObject *arg
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_complex_t_append", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_complex_T_append", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_append" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_append" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_std_complex_Sl_double_Sg_(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t_append" "', argument " "2"" of type '" "std::vector< std::complex< double > >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T_append" "', argument " "2"" of type '" "std::vector< std::complex< double > >::value_type""'");
   } 
   temp2 = static_cast< std::vector< std::complex< double > >::value_type >(val2);
   arg2 = &temp2;
@@ -18243,7 +18243,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_complex_t__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
+SWIGINTERN PyObject *_wrap_new_vector_complex_T__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *result = 0 ;
   
@@ -18257,7 +18257,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_complex_t__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_complex_T__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = 0 ;
   int res1 = SWIG_OLDOBJ ;
@@ -18269,10 +18269,10 @@ SWIGINTERN PyObject *_wrap_new_vector_complex_t__SWIG_1(PyObject *self, Py_ssize
     std::vector< std::complex< double >,std::allocator< std::complex< double > > > *ptr = (std::vector< std::complex< double >,std::allocator< std::complex< double > > > *)0;
     res1 = swig::asptr(swig_obj[0], &ptr);
     if (!SWIG_IsOK(res1)) {
-      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vector_complex_t" "', argument " "1"" of type '" "std::vector< std::complex< double > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vector_complex_T" "', argument " "1"" of type '" "std::vector< std::complex< double > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_complex_t" "', argument " "1"" of type '" "std::vector< std::complex< double > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_complex_T" "', argument " "1"" of type '" "std::vector< std::complex< double > > const &""'"); 
     }
     arg1 = ptr;
   }
@@ -18286,7 +18286,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_empty(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_empty(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -18299,7 +18299,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_empty(PyObject *self, PyObject *args
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_empty" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_empty" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = (bool)((std::vector< std::complex< double > > const *)arg1)->empty();
@@ -18310,7 +18310,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_size(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_size(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -18323,7 +18323,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_size(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_size" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_size" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = ((std::vector< std::complex< double > > const *)arg1)->size();
@@ -18334,7 +18334,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_swap(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_swap(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > > *arg2 = 0 ;
@@ -18345,18 +18345,18 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_swap(PyObject *self, PyObject *args)
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_complex_t_swap", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_complex_T_swap", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_swap" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_swap" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], &argp2, SWIGTYPE_p_std__vectorT_std__complexT_double_t_t,  0 );
   if (!SWIG_IsOK(res2)) {
-    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_complex_t_swap" "', argument " "2"" of type '" "std::vector< std::complex< double > > &""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_complex_T_swap" "', argument " "2"" of type '" "std::vector< std::complex< double > > &""'"); 
   }
   if (!argp2) {
-    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_complex_t_swap" "', argument " "2"" of type '" "std::vector< std::complex< double > > &""'"); 
+    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_complex_T_swap" "', argument " "2"" of type '" "std::vector< std::complex< double > > &""'"); 
   }
   arg2 = reinterpret_cast< std::vector< std::complex< double > > * >(argp2);
   (arg1)->swap(*arg2);
@@ -18367,7 +18367,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_begin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_begin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -18380,7 +18380,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_begin(PyObject *self, PyObject *args
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_begin" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_begin" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = (arg1)->begin();
@@ -18392,7 +18392,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_end(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_end(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -18405,7 +18405,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_end(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_end" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_end" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = (arg1)->end();
@@ -18417,7 +18417,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_rbegin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_rbegin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -18430,7 +18430,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_rbegin(PyObject *self, PyObject *arg
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_rbegin" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_rbegin" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = (arg1)->rbegin();
@@ -18442,7 +18442,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_rend(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_rend(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -18455,7 +18455,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_rend(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_rend" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_rend" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = (arg1)->rend();
@@ -18467,7 +18467,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_clear(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_clear(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -18479,7 +18479,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_clear(PyObject *self, PyObject *args
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_clear" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_clear" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   (arg1)->clear();
@@ -18490,7 +18490,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_get_allocator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_get_allocator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -18503,7 +18503,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_get_allocator(PyObject *self, PyObje
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_get_allocator" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_get_allocator" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = ((std::vector< std::complex< double > > const *)arg1)->get_allocator();
@@ -18514,7 +18514,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_complex_t__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_complex_T__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > >::size_type arg1 ;
   size_t val1 ;
@@ -18525,7 +18525,7 @@ SWIGINTERN PyObject *_wrap_new_vector_complex_t__SWIG_2(PyObject *self, Py_ssize
   if ((nobjs < 1) || (nobjs > 1)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_complex_t" "', argument " "1"" of type '" "std::vector< std::complex< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_complex_T" "', argument " "1"" of type '" "std::vector< std::complex< double > >::size_type""'");
   } 
   arg1 = static_cast< std::vector< std::complex< double > >::size_type >(val1);
   result = (std::vector< std::complex< double > > *)new std::vector< std::complex< double > >(arg1);
@@ -18536,7 +18536,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_pop_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_pop_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -18548,7 +18548,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_pop_back(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_pop_back" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_pop_back" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   (arg1)->pop_back();
@@ -18559,7 +18559,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::size_type arg2 ;
@@ -18572,12 +18572,12 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_resize__SWIG_0(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_resize" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_resize" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t_resize" "', argument " "2"" of type '" "std::vector< std::complex< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T_resize" "', argument " "2"" of type '" "std::vector< std::complex< double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::complex< double > >::size_type >(val2);
   (arg1)->resize(arg2);
@@ -18588,7 +18588,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::iterator arg2 ;
@@ -18602,18 +18602,18 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_erase__SWIG_0(PyObject *self, Py_ssi
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_erase" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_erase" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t_erase" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T_erase" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t_erase" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T_erase" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
     }
   }
   result = std_vector_Sl_std_complex_Sl_double_Sg__Sg__erase__SWIG_0(arg1,SWIG_STD_MOVE(arg2));
@@ -18625,7 +18625,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::iterator arg2 ;
@@ -18642,29 +18642,29 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_erase__SWIG_1(PyObject *self, Py_ssi
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_erase" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_erase" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t_erase" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T_erase" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t_erase" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T_erase" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
     }
   }
   res3 = SWIG_ConvertPtr(swig_obj[2], SWIG_as_voidptrptr(&iter3), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res3) || !iter3) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t_erase" "', argument " "3"" of type '" "std::vector< std::complex< double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T_erase" "', argument " "3"" of type '" "std::vector< std::complex< double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *>(iter3);
     if (iter_t) {
       arg3 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t_erase" "', argument " "3"" of type '" "std::vector< std::complex< double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T_erase" "', argument " "3"" of type '" "std::vector< std::complex< double > >::iterator""'");
     }
   }
   result = std_vector_Sl_std_complex_Sl_double_Sg__Sg__erase__SWIG_1(arg1,SWIG_STD_MOVE(arg2),SWIG_STD_MOVE(arg3));
@@ -18676,13 +18676,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_erase(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_erase(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_t_erase", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_T_erase", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -18693,7 +18693,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_erase(PyObject *self, PyObject *args
       int res = SWIG_ConvertPtr(argv[1], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
       _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *>(iter) != 0));
       if (_v) {
-        return _wrap_vector_complex_t_erase__SWIG_0(self, argc, argv);
+        return _wrap_vector_complex_T_erase__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -18710,14 +18710,14 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_erase(PyObject *self, PyObject *args
         int res = SWIG_ConvertPtr(argv[2], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
         _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *>(iter) != 0));
         if (_v) {
-          return _wrap_vector_complex_t_erase__SWIG_1(self, argc, argv);
+          return _wrap_vector_complex_T_erase__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_t_erase'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_T_erase'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::complex< double > >::erase(std::vector< std::complex< double > >::iterator)\n"
     "    std::vector< std::complex< double > >::erase(std::vector< std::complex< double > >::iterator,std::vector< std::complex< double > >::iterator)\n");
@@ -18725,7 +18725,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_complex_t__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_complex_T__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > >::size_type arg1 ;
   std::vector< std::complex< double > >::value_type *arg2 = 0 ;
@@ -18740,12 +18740,12 @@ SWIGINTERN PyObject *_wrap_new_vector_complex_t__SWIG_3(PyObject *self, Py_ssize
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_complex_t" "', argument " "1"" of type '" "std::vector< std::complex< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_complex_T" "', argument " "1"" of type '" "std::vector< std::complex< double > >::size_type""'");
   } 
   arg1 = static_cast< std::vector< std::complex< double > >::size_type >(val1);
   ecode2 = SWIG_AsVal_std_complex_Sl_double_Sg_(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "new_vector_complex_t" "', argument " "2"" of type '" "std::vector< std::complex< double > >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "new_vector_complex_T" "', argument " "2"" of type '" "std::vector< std::complex< double > >::value_type""'");
   } 
   temp2 = static_cast< std::vector< std::complex< double > >::value_type >(val2);
   arg2 = &temp2;
@@ -18757,16 +18757,16 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_complex_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_new_vector_complex_T(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vector_complex_t", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vector_complex_T", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 0) {
-    return _wrap_new_vector_complex_t__SWIG_0(self, argc, argv);
+    return _wrap_new_vector_complex_T__SWIG_0(self, argc, argv);
   }
   if (argc == 1) {
     int _v = 0;
@@ -18775,7 +18775,7 @@ SWIGINTERN PyObject *_wrap_new_vector_complex_t(PyObject *self, PyObject *args)
       _v = SWIG_CheckState(res);
     }
     if (_v) {
-      return _wrap_new_vector_complex_t__SWIG_2(self, argc, argv);
+      return _wrap_new_vector_complex_T__SWIG_2(self, argc, argv);
     }
   }
   if (argc == 1) {
@@ -18783,7 +18783,7 @@ SWIGINTERN PyObject *_wrap_new_vector_complex_t(PyObject *self, PyObject *args)
     int res = swig::asptr(argv[0], (std::vector< std::complex< double >,std::allocator< std::complex< double > > >**)(0));
     _v = SWIG_CheckState(res);
     if (_v) {
-      return _wrap_new_vector_complex_t__SWIG_1(self, argc, argv);
+      return _wrap_new_vector_complex_T__SWIG_1(self, argc, argv);
     }
   }
   if (argc == 2) {
@@ -18798,13 +18798,13 @@ SWIGINTERN PyObject *_wrap_new_vector_complex_t(PyObject *self, PyObject *args)
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_new_vector_complex_t__SWIG_3(self, argc, argv);
+        return _wrap_new_vector_complex_T__SWIG_3(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vector_complex_t'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vector_complex_T'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::complex< double > >::vector()\n"
     "    std::vector< std::complex< double > >::vector(std::vector< std::complex< double > > const &)\n"
@@ -18814,7 +18814,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_push_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_push_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::value_type *arg2 = 0 ;
@@ -18826,15 +18826,15 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_push_back(PyObject *self, PyObject *
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_complex_t_push_back", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_complex_T_push_back", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_push_back" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_push_back" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_std_complex_Sl_double_Sg_(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t_push_back" "', argument " "2"" of type '" "std::vector< std::complex< double > >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T_push_back" "', argument " "2"" of type '" "std::vector< std::complex< double > >::value_type""'");
   } 
   temp2 = static_cast< std::vector< std::complex< double > >::value_type >(val2);
   arg2 = &temp2;
@@ -18846,7 +18846,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_front(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_front(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -18859,7 +18859,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_front(PyObject *self, PyObject *args
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_front" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_front" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = (std::vector< std::complex< double > >::value_type *) &((std::vector< std::complex< double > > const *)arg1)->front();
@@ -18871,7 +18871,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -18884,7 +18884,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_back(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_back" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_back" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = (std::vector< std::complex< double > >::value_type *) &((std::vector< std::complex< double > > const *)arg1)->back();
@@ -18896,7 +18896,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_assign(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_assign(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::size_type arg2 ;
@@ -18911,20 +18911,20 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_assign(PyObject *self, PyObject *arg
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_complex_t_assign", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_complex_T_assign", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_assign" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_assign" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t_assign" "', argument " "2"" of type '" "std::vector< std::complex< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T_assign" "', argument " "2"" of type '" "std::vector< std::complex< double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::complex< double > >::size_type >(val2);
   ecode3 = SWIG_AsVal_std_complex_Sl_double_Sg_(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_t_assign" "', argument " "3"" of type '" "std::vector< std::complex< double > >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_T_assign" "', argument " "3"" of type '" "std::vector< std::complex< double > >::value_type""'");
   } 
   temp3 = static_cast< std::vector< std::complex< double > >::value_type >(val3);
   arg3 = &temp3;
@@ -18936,7 +18936,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::size_type arg2 ;
@@ -18953,17 +18953,17 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_resize__SWIG_1(PyObject *self, Py_ss
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_resize" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_resize" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t_resize" "', argument " "2"" of type '" "std::vector< std::complex< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T_resize" "', argument " "2"" of type '" "std::vector< std::complex< double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::complex< double > >::size_type >(val2);
   ecode3 = SWIG_AsVal_std_complex_Sl_double_Sg_(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_t_resize" "', argument " "3"" of type '" "std::vector< std::complex< double > >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_T_resize" "', argument " "3"" of type '" "std::vector< std::complex< double > >::value_type""'");
   } 
   temp3 = static_cast< std::vector< std::complex< double > >::value_type >(val3);
   arg3 = &temp3;
@@ -18975,13 +18975,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_resize(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_resize(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_t_resize", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_T_resize", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -18993,7 +18993,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_resize(PyObject *self, PyObject *arg
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_complex_t_resize__SWIG_0(self, argc, argv);
+        return _wrap_vector_complex_T_resize__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -19012,14 +19012,14 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_resize(PyObject *self, PyObject *arg
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_complex_t_resize__SWIG_1(self, argc, argv);
+          return _wrap_vector_complex_T_resize__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_t_resize'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_T_resize'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::complex< double > >::resize(std::vector< std::complex< double > >::size_type)\n"
     "    std::vector< std::complex< double > >::resize(std::vector< std::complex< double > >::size_type,std::vector< std::complex< double > >::value_type const &)\n");
@@ -19027,7 +19027,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::iterator arg2 ;
@@ -19045,23 +19045,23 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_insert__SWIG_0(PyObject *self, Py_ss
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_insert" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_insert" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t_insert" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T_insert" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t_insert" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T_insert" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_std_complex_Sl_double_Sg_(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_t_insert" "', argument " "3"" of type '" "std::vector< std::complex< double > >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_T_insert" "', argument " "3"" of type '" "std::vector< std::complex< double > >::value_type""'");
   } 
   temp3 = static_cast< std::vector< std::complex< double > >::value_type >(val3);
   arg3 = &temp3;
@@ -19074,7 +19074,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::iterator arg2 ;
@@ -19094,28 +19094,28 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_insert__SWIG_1(PyObject *self, Py_ss
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_insert" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_insert" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t_insert" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T_insert" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t_insert" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T_insert" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_size_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_t_insert" "', argument " "3"" of type '" "std::vector< std::complex< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_T_insert" "', argument " "3"" of type '" "std::vector< std::complex< double > >::size_type""'");
   } 
   arg3 = static_cast< std::vector< std::complex< double > >::size_type >(val3);
   ecode4 = SWIG_AsVal_std_complex_Sl_double_Sg_(swig_obj[3], &val4);
   if (!SWIG_IsOK(ecode4)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode4), "in method '" "vector_complex_t_insert" "', argument " "4"" of type '" "std::vector< std::complex< double > >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode4), "in method '" "vector_complex_T_insert" "', argument " "4"" of type '" "std::vector< std::complex< double > >::value_type""'");
   } 
   temp4 = static_cast< std::vector< std::complex< double > >::value_type >(val4);
   arg4 = &temp4;
@@ -19127,13 +19127,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_insert(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_insert(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_t_insert", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_T_insert", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -19149,7 +19149,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_insert(PyObject *self, PyObject *arg
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_complex_t_insert__SWIG_0(self, argc, argv);
+          return _wrap_vector_complex_T_insert__SWIG_0(self, argc, argv);
         }
       }
     }
@@ -19173,7 +19173,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_insert(PyObject *self, PyObject *arg
             _v = SWIG_CheckState(res);
           }
           if (_v) {
-            return _wrap_vector_complex_t_insert__SWIG_1(self, argc, argv);
+            return _wrap_vector_complex_T_insert__SWIG_1(self, argc, argv);
           }
         }
       }
@@ -19181,7 +19181,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_insert(PyObject *self, PyObject *arg
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_t_insert'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_T_insert'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::complex< double > >::insert(std::vector< std::complex< double > >::iterator,std::vector< std::complex< double > >::value_type const &)\n"
     "    std::vector< std::complex< double > >::insert(std::vector< std::complex< double > >::iterator,std::vector< std::complex< double > >::size_type,std::vector< std::complex< double > >::value_type const &)\n");
@@ -19189,7 +19189,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_reserve(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_reserve(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::size_type arg2 ;
@@ -19200,15 +19200,15 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_reserve(PyObject *self, PyObject *ar
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_complex_t_reserve", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_complex_T_reserve", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_reserve" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_reserve" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t_reserve" "', argument " "2"" of type '" "std::vector< std::complex< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T_reserve" "', argument " "2"" of type '" "std::vector< std::complex< double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::complex< double > >::size_type >(val2);
   (arg1)->reserve(arg2);
@@ -19219,7 +19219,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_capacity(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_capacity(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -19232,7 +19232,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_capacity(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_capacity" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_capacity" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = ((std::vector< std::complex< double > > const *)arg1)->capacity();
@@ -19243,7 +19243,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_delete_vector_complex_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_delete_vector_complex_T(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -19255,7 +19255,7 @@ SWIGINTERN PyObject *_wrap_delete_vector_complex_t(PyObject *self, PyObject *arg
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, SWIG_POINTER_DISOWN |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vector_complex_t" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vector_complex_T" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   {
@@ -19276,18 +19276,18 @@ fail:
 }
 
 
-SWIGINTERN PyObject *vector_complex_t_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vector_complex_T_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   PyObject *obj;
   if (!SWIG_Python_UnpackTuple(args, "swigregister", 1, 1, &obj)) return NULL;
   SWIG_TypeNewClientData(SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, SWIG_NewClientData(obj));
   return SWIG_Py_Void();
 }
 
-SWIGINTERN PyObject *vector_complex_t_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vector_complex_T_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   return SWIG_Python_InitShadowInstance(args);
 }
 
-SWIGINTERN PyObject *_wrap_vector_string_t_iterator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_iterator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   PyObject **arg2 = (PyObject **) 0 ;
@@ -19302,7 +19302,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_iterator(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_iterator" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_iterator" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = (swig::SwigPyIterator *)std_vector_Sl_std_string_Sg__iterator(arg1,arg2);
@@ -19313,7 +19313,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___nonzero__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T___nonzero__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -19326,7 +19326,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t___nonzero__(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___nonzero__" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___nonzero__" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = (bool)std_vector_Sl_std_string_Sg____nonzero__((std::vector< std::string > const *)arg1);
@@ -19337,7 +19337,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___bool__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T___bool__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -19350,7 +19350,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t___bool__(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___bool__" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___bool__" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = (bool)std_vector_Sl_std_string_Sg____bool__((std::vector< std::string > const *)arg1);
@@ -19361,7 +19361,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___len__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T___len__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -19374,7 +19374,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t___len__(PyObject *self, PyObject *arg
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___len__" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___len__" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = std_vector_Sl_std_string_Sg____len__((std::vector< std::string > const *)arg1);
@@ -19385,7 +19385,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___getslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T___getslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::difference_type arg2 ;
@@ -19400,20 +19400,20 @@ SWIGINTERN PyObject *_wrap_vector_string_t___getslice__(PyObject *self, PyObject
   std::vector< std::string,std::allocator< std::string > > *result = 0 ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_string_t___getslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_string_T___getslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___getslice__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___getslice__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_t___getslice__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_T___getslice__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::string >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_string_t___getslice__" "', argument " "3"" of type '" "std::vector< std::string >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_string_T___getslice__" "', argument " "3"" of type '" "std::vector< std::string >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::string >::difference_type >(val3);
   try {
@@ -19430,7 +19430,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::difference_type arg2 ;
@@ -19446,17 +19446,17 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setslice____SWIG_0(PyObject *self,
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___setslice__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___setslice__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_t___setslice__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_T___setslice__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::string >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_string_t___setslice__" "', argument " "3"" of type '" "std::vector< std::string >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_string_T___setslice__" "', argument " "3"" of type '" "std::vector< std::string >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::string >::difference_type >(val3);
   try {
@@ -19473,7 +19473,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::difference_type arg2 ;
@@ -19491,27 +19491,27 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setslice____SWIG_1(PyObject *self,
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___setslice__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___setslice__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_t___setslice__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_T___setslice__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::string >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_string_t___setslice__" "', argument " "3"" of type '" "std::vector< std::string >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_string_T___setslice__" "', argument " "3"" of type '" "std::vector< std::string >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::string >::difference_type >(val3);
   {
     std::vector< std::string,std::allocator< std::string > > *ptr = (std::vector< std::string,std::allocator< std::string > > *)0;
     res4 = swig::asptr(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_string_t___setslice__" "', argument " "4"" of type '" "std::vector< std::string,std::allocator< std::string > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_string_T___setslice__" "', argument " "4"" of type '" "std::vector< std::string,std::allocator< std::string > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_t___setslice__" "', argument " "4"" of type '" "std::vector< std::string,std::allocator< std::string > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_T___setslice__" "', argument " "4"" of type '" "std::vector< std::string,std::allocator< std::string > > const &""'"); 
     }
     arg4 = ptr;
   }
@@ -19531,13 +19531,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___setslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T___setslice__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_t___setslice__", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_T___setslice__", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -19554,7 +19554,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setslice__(PyObject *self, PyObject
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_string_t___setslice____SWIG_0(self, argc, argv);
+          return _wrap_vector_string_T___setslice____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -19577,7 +19577,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setslice__(PyObject *self, PyObject
           int res = swig::asptr(argv[3], (std::vector< std::string,std::allocator< std::string > >**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vector_string_t___setslice____SWIG_1(self, argc, argv);
+            return _wrap_vector_string_T___setslice____SWIG_1(self, argc, argv);
           }
         }
       }
@@ -19585,7 +19585,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setslice__(PyObject *self, PyObject
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_t___setslice__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_T___setslice__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::string >::__setslice__(std::vector< std::string >::difference_type,std::vector< std::string >::difference_type)\n"
     "    std::vector< std::string >::__setslice__(std::vector< std::string >::difference_type,std::vector< std::string >::difference_type,std::vector< std::string,std::allocator< std::string > > const &)\n");
@@ -19593,7 +19593,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___delslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T___delslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::difference_type arg2 ;
@@ -19607,20 +19607,20 @@ SWIGINTERN PyObject *_wrap_vector_string_t___delslice__(PyObject *self, PyObject
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_string_t___delslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_string_T___delslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___delslice__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___delslice__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_t___delslice__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_T___delslice__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::string >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_string_t___delslice__" "', argument " "3"" of type '" "std::vector< std::string >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_string_T___delslice__" "', argument " "3"" of type '" "std::vector< std::string >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::string >::difference_type >(val3);
   try {
@@ -19637,7 +19637,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::difference_type arg2 ;
@@ -19650,12 +19650,12 @@ SWIGINTERN PyObject *_wrap_vector_string_t___delitem____SWIG_0(PyObject *self, P
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___delitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___delitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_t___delitem__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_T___delitem__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::string >::difference_type >(val2);
   try {
@@ -19672,7 +19672,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -19684,12 +19684,12 @@ SWIGINTERN PyObject *_wrap_vector_string_t___getitem____SWIG_0(PyObject *self, P
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___getitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___getitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -19707,7 +19707,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -19720,12 +19720,12 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setitem____SWIG_0(PyObject *self, P
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___setitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___setitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -19733,10 +19733,10 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setitem____SWIG_0(PyObject *self, P
     std::vector< std::string,std::allocator< std::string > > *ptr = (std::vector< std::string,std::allocator< std::string > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_string_t___setitem__" "', argument " "3"" of type '" "std::vector< std::string,std::allocator< std::string > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_string_T___setitem__" "', argument " "3"" of type '" "std::vector< std::string,std::allocator< std::string > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_t___setitem__" "', argument " "3"" of type '" "std::vector< std::string,std::allocator< std::string > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_T___setitem__" "', argument " "3"" of type '" "std::vector< std::string,std::allocator< std::string > > const &""'"); 
     }
     arg3 = ptr;
   }
@@ -19756,7 +19756,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -19767,12 +19767,12 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setitem____SWIG_1(PyObject *self, P
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___setitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___setitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -19790,7 +19790,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -19801,12 +19801,12 @@ SWIGINTERN PyObject *_wrap_vector_string_t___delitem____SWIG_1(PyObject *self, P
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___delitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___delitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -19824,13 +19824,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___delitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T___delitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_t___delitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_T___delitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -19841,7 +19841,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t___delitem__(PyObject *self, PyObject
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_string_t___delitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_string_T___delitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -19855,13 +19855,13 @@ SWIGINTERN PyObject *_wrap_vector_string_t___delitem__(PyObject *self, PyObject
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_string_t___delitem____SWIG_0(self, argc, argv);
+        return _wrap_vector_string_T___delitem____SWIG_0(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_t___delitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_T___delitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::string >::__delitem__(std::vector< std::string >::difference_type)\n"
     "    std::vector< std::string >::__delitem__(SWIGPY_SLICEOBJECT *)\n");
@@ -19869,7 +19869,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::difference_type arg2 ;
@@ -19883,12 +19883,12 @@ SWIGINTERN PyObject *_wrap_vector_string_t___getitem____SWIG_1(PyObject *self, P
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___getitem__" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___getitem__" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_t___getitem__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_T___getitem__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::string >::difference_type >(val2);
   try {
@@ -19904,13 +19904,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___getitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T___getitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_t___getitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_T___getitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -19921,7 +19921,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t___getitem__(PyObject *self, PyObject
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_string_t___getitem____SWIG_0(self, argc, argv);
+        return _wrap_vector_string_T___getitem____SWIG_0(self, argc, argv);
       }
     }
   }
@@ -19935,13 +19935,13 @@ SWIGINTERN PyObject *_wrap_vector_string_t___getitem__(PyObject *self, PyObject
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_string_t___getitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_string_T___getitem____SWIG_1(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_t___getitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_T___getitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::string >::__getitem__(SWIGPY_SLICEOBJECT *)\n"
     "    std::vector< std::string >::__getitem__(std::vector< std::string >::difference_type) const\n");
@@ -19949,7 +19949,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::difference_type arg2 ;
@@ -19964,22 +19964,22 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setitem____SWIG_2(PyObject *self, P
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___setitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___setitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_t___setitem__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_T___setitem__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::string >::difference_type >(val2);
   {
     std::string *ptr = (std::string *)0;
     res3 = SWIG_AsPtr_std_string(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_string_t___setitem__" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_string_T___setitem__" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_t___setitem__" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_T___setitem__" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -19997,13 +19997,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___setitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T___setitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_t___setitem__", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_T___setitem__", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -20014,7 +20014,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setitem__(PyObject *self, PyObject
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_string_t___setitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_string_T___setitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -20030,7 +20030,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setitem__(PyObject *self, PyObject
         int res = swig::asptr(argv[2], (std::vector< std::string,std::allocator< std::string > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vector_string_t___setitem____SWIG_0(self, argc, argv);
+          return _wrap_vector_string_T___setitem____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -20048,14 +20048,14 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setitem__(PyObject *self, PyObject
         int res = SWIG_AsPtr_std_string(argv[2], (std::string**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vector_string_t___setitem____SWIG_2(self, argc, argv);
+          return _wrap_vector_string_T___setitem____SWIG_2(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_t___setitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_T___setitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::string >::__setitem__(SWIGPY_SLICEOBJECT *,std::vector< std::string,std::allocator< std::string > > const &)\n"
     "    std::vector< std::string >::__setitem__(SWIGPY_SLICEOBJECT *)\n"
@@ -20064,7 +20064,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_pop(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_pop(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -20077,7 +20077,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_pop(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_pop" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_pop" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   try {
@@ -20092,7 +20092,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_append(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_append(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::value_type *arg2 = 0 ;
@@ -20102,20 +20102,20 @@ SWIGINTERN PyObject *_wrap_vector_string_t_append(PyObject *self, PyObject *args
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_string_t_append", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_string_T_append", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_append" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_append" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_string_t_append" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_string_T_append" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_t_append" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_T_append" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -20129,7 +20129,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_string_t__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
+SWIGINTERN PyObject *_wrap_new_vector_string_T__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
   PyObject *resultobj = 0;
   std::vector< std::string > *result = 0 ;
   
@@ -20143,7 +20143,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_string_t__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_string_T__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = 0 ;
   int res1 = SWIG_OLDOBJ ;
@@ -20155,10 +20155,10 @@ SWIGINTERN PyObject *_wrap_new_vector_string_t__SWIG_1(PyObject *self, Py_ssize_
     std::vector< std::string,std::allocator< std::string > > *ptr = (std::vector< std::string,std::allocator< std::string > > *)0;
     res1 = swig::asptr(swig_obj[0], &ptr);
     if (!SWIG_IsOK(res1)) {
-      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vector_string_t" "', argument " "1"" of type '" "std::vector< std::string > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vector_string_T" "', argument " "1"" of type '" "std::vector< std::string > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_string_t" "', argument " "1"" of type '" "std::vector< std::string > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_string_T" "', argument " "1"" of type '" "std::vector< std::string > const &""'"); 
     }
     arg1 = ptr;
   }
@@ -20172,7 +20172,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_empty(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_empty(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -20185,7 +20185,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_empty(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_empty" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_empty" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = (bool)((std::vector< std::string > const *)arg1)->empty();
@@ -20196,7 +20196,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_size(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_size(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -20209,7 +20209,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_size(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_size" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_size" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = ((std::vector< std::string > const *)arg1)->size();
@@ -20220,7 +20220,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_swap(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_swap(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string > *arg2 = 0 ;
@@ -20231,18 +20231,18 @@ SWIGINTERN PyObject *_wrap_vector_string_t_swap(PyObject *self, PyObject *args)
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_string_t_swap", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_string_T_swap", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_swap" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_swap" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], &argp2, SWIGTYPE_p_std__vectorT_std__string_t,  0 );
   if (!SWIG_IsOK(res2)) {
-    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_string_t_swap" "', argument " "2"" of type '" "std::vector< std::string > &""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_string_T_swap" "', argument " "2"" of type '" "std::vector< std::string > &""'"); 
   }
   if (!argp2) {
-    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_t_swap" "', argument " "2"" of type '" "std::vector< std::string > &""'"); 
+    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_T_swap" "', argument " "2"" of type '" "std::vector< std::string > &""'"); 
   }
   arg2 = reinterpret_cast< std::vector< std::string > * >(argp2);
   (arg1)->swap(*arg2);
@@ -20253,7 +20253,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_begin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_begin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -20266,7 +20266,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_begin(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_begin" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_begin" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = (arg1)->begin();
@@ -20278,7 +20278,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_end(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_end(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -20291,7 +20291,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_end(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_end" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_end" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = (arg1)->end();
@@ -20303,7 +20303,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_rbegin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_rbegin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -20316,7 +20316,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_rbegin(PyObject *self, PyObject *args
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_rbegin" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_rbegin" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = (arg1)->rbegin();
@@ -20328,7 +20328,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_rend(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_rend(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -20341,7 +20341,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_rend(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_rend" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_rend" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = (arg1)->rend();
@@ -20353,7 +20353,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_clear(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_clear(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -20365,7 +20365,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_clear(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_clear" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_clear" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   (arg1)->clear();
@@ -20376,7 +20376,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_get_allocator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_get_allocator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -20389,7 +20389,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_get_allocator(PyObject *self, PyObjec
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_get_allocator" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_get_allocator" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = ((std::vector< std::string > const *)arg1)->get_allocator();
@@ -20400,7 +20400,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_string_t__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_string_T__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string >::size_type arg1 ;
   size_t val1 ;
@@ -20411,7 +20411,7 @@ SWIGINTERN PyObject *_wrap_new_vector_string_t__SWIG_2(PyObject *self, Py_ssize_
   if ((nobjs < 1) || (nobjs > 1)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_string_t" "', argument " "1"" of type '" "std::vector< std::string >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_string_T" "', argument " "1"" of type '" "std::vector< std::string >::size_type""'");
   } 
   arg1 = static_cast< std::vector< std::string >::size_type >(val1);
   result = (std::vector< std::string > *)new std::vector< std::string >(arg1);
@@ -20422,7 +20422,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_pop_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_pop_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -20434,7 +20434,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_pop_back(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_pop_back" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_pop_back" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   (arg1)->pop_back();
@@ -20445,7 +20445,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::size_type arg2 ;
@@ -20458,12 +20458,12 @@ SWIGINTERN PyObject *_wrap_vector_string_t_resize__SWIG_0(PyObject *self, Py_ssi
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_resize" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_resize" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_t_resize" "', argument " "2"" of type '" "std::vector< std::string >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_T_resize" "', argument " "2"" of type '" "std::vector< std::string >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::string >::size_type >(val2);
   (arg1)->resize(arg2);
@@ -20474,7 +20474,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::iterator arg2 ;
@@ -20488,18 +20488,18 @@ SWIGINTERN PyObject *_wrap_vector_string_t_erase__SWIG_0(PyObject *self, Py_ssiz
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_erase" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_erase" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t_erase" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T_erase" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::string >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::string >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t_erase" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T_erase" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
     }
   }
   result = std_vector_Sl_std_string_Sg__erase__SWIG_0(arg1,SWIG_STD_MOVE(arg2));
@@ -20511,7 +20511,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::iterator arg2 ;
@@ -20528,29 +20528,29 @@ SWIGINTERN PyObject *_wrap_vector_string_t_erase__SWIG_1(PyObject *self, Py_ssiz
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_erase" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_erase" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t_erase" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T_erase" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::string >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::string >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t_erase" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T_erase" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
     }
   }
   res3 = SWIG_ConvertPtr(swig_obj[2], SWIG_as_voidptrptr(&iter3), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res3) || !iter3) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t_erase" "', argument " "3"" of type '" "std::vector< std::string >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T_erase" "', argument " "3"" of type '" "std::vector< std::string >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::string >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::string >::iterator > *>(iter3);
     if (iter_t) {
       arg3 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t_erase" "', argument " "3"" of type '" "std::vector< std::string >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T_erase" "', argument " "3"" of type '" "std::vector< std::string >::iterator""'");
     }
   }
   result = std_vector_Sl_std_string_Sg__erase__SWIG_1(arg1,SWIG_STD_MOVE(arg2),SWIG_STD_MOVE(arg3));
@@ -20562,13 +20562,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_erase(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_erase(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_t_erase", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_T_erase", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -20579,7 +20579,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_erase(PyObject *self, PyObject *args)
       int res = SWIG_ConvertPtr(argv[1], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
       _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< std::string >::iterator > *>(iter) != 0));
       if (_v) {
-        return _wrap_vector_string_t_erase__SWIG_0(self, argc, argv);
+        return _wrap_vector_string_T_erase__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -20596,14 +20596,14 @@ SWIGINTERN PyObject *_wrap_vector_string_t_erase(PyObject *self, PyObject *args)
         int res = SWIG_ConvertPtr(argv[2], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
         _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< std::string >::iterator > *>(iter) != 0));
         if (_v) {
-          return _wrap_vector_string_t_erase__SWIG_1(self, argc, argv);
+          return _wrap_vector_string_T_erase__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_t_erase'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_T_erase'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::string >::erase(std::vector< std::string >::iterator)\n"
     "    std::vector< std::string >::erase(std::vector< std::string >::iterator,std::vector< std::string >::iterator)\n");
@@ -20611,7 +20611,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_string_t__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_string_T__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string >::size_type arg1 ;
   std::vector< std::string >::value_type *arg2 = 0 ;
@@ -20624,17 +20624,17 @@ SWIGINTERN PyObject *_wrap_new_vector_string_t__SWIG_3(PyObject *self, Py_ssize_
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_string_t" "', argument " "1"" of type '" "std::vector< std::string >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_string_T" "', argument " "1"" of type '" "std::vector< std::string >::size_type""'");
   } 
   arg1 = static_cast< std::vector< std::string >::size_type >(val1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "new_vector_string_t" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "new_vector_string_T" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_string_t" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_string_T" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -20648,16 +20648,16 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_string_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_new_vector_string_T(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vector_string_t", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vector_string_T", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 0) {
-    return _wrap_new_vector_string_t__SWIG_0(self, argc, argv);
+    return _wrap_new_vector_string_T__SWIG_0(self, argc, argv);
   }
   if (argc == 1) {
     int _v = 0;
@@ -20666,7 +20666,7 @@ SWIGINTERN PyObject *_wrap_new_vector_string_t(PyObject *self, PyObject *args) {
       _v = SWIG_CheckState(res);
     }
     if (_v) {
-      return _wrap_new_vector_string_t__SWIG_2(self, argc, argv);
+      return _wrap_new_vector_string_T__SWIG_2(self, argc, argv);
     }
   }
   if (argc == 1) {
@@ -20674,7 +20674,7 @@ SWIGINTERN PyObject *_wrap_new_vector_string_t(PyObject *self, PyObject *args) {
     int res = swig::asptr(argv[0], (std::vector< std::string,std::allocator< std::string > >**)(0));
     _v = SWIG_CheckState(res);
     if (_v) {
-      return _wrap_new_vector_string_t__SWIG_1(self, argc, argv);
+      return _wrap_new_vector_string_T__SWIG_1(self, argc, argv);
     }
   }
   if (argc == 2) {
@@ -20687,13 +20687,13 @@ SWIGINTERN PyObject *_wrap_new_vector_string_t(PyObject *self, PyObject *args) {
       int res = SWIG_AsPtr_std_string(argv[1], (std::string**)(0));
       _v = SWIG_CheckState(res);
       if (_v) {
-        return _wrap_new_vector_string_t__SWIG_3(self, argc, argv);
+        return _wrap_new_vector_string_T__SWIG_3(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vector_string_t'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vector_string_T'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::string >::vector()\n"
     "    std::vector< std::string >::vector(std::vector< std::string > const &)\n"
@@ -20703,7 +20703,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_push_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_push_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::value_type *arg2 = 0 ;
@@ -20713,20 +20713,20 @@ SWIGINTERN PyObject *_wrap_vector_string_t_push_back(PyObject *self, PyObject *a
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_string_t_push_back", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_string_T_push_back", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_push_back" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_push_back" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_string_t_push_back" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_string_T_push_back" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_t_push_back" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_T_push_back" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -20740,7 +20740,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_front(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_front(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -20753,7 +20753,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_front(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_front" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_front" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = (std::vector< std::string >::value_type *) &((std::vector< std::string > const *)arg1)->front();
@@ -20765,7 +20765,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -20778,7 +20778,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_back(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_back" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_back" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = (std::vector< std::string >::value_type *) &((std::vector< std::string > const *)arg1)->back();
@@ -20790,7 +20790,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_assign(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_assign(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::size_type arg2 ;
@@ -20803,25 +20803,25 @@ SWIGINTERN PyObject *_wrap_vector_string_t_assign(PyObject *self, PyObject *args
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_string_t_assign", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_string_T_assign", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_assign" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_assign" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_t_assign" "', argument " "2"" of type '" "std::vector< std::string >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_T_assign" "', argument " "2"" of type '" "std::vector< std::string >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::string >::size_type >(val2);
   {
     std::string *ptr = (std::string *)0;
     res3 = SWIG_AsPtr_std_string(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_string_t_assign" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_string_T_assign" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_t_assign" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_T_assign" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -20835,7 +20835,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::size_type arg2 ;
@@ -20850,22 +20850,22 @@ SWIGINTERN PyObject *_wrap_vector_string_t_resize__SWIG_1(PyObject *self, Py_ssi
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_resize" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_resize" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_t_resize" "', argument " "2"" of type '" "std::vector< std::string >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_T_resize" "', argument " "2"" of type '" "std::vector< std::string >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::string >::size_type >(val2);
   {
     std::string *ptr = (std::string *)0;
     res3 = SWIG_AsPtr_std_string(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_string_t_resize" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_string_T_resize" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_t_resize" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_T_resize" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -20879,13 +20879,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_resize(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_resize(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_t_resize", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_T_resize", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -20897,7 +20897,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_resize(PyObject *self, PyObject *args
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_string_t_resize__SWIG_0(self, argc, argv);
+        return _wrap_vector_string_T_resize__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -20914,14 +20914,14 @@ SWIGINTERN PyObject *_wrap_vector_string_t_resize(PyObject *self, PyObject *args
         int res = SWIG_AsPtr_std_string(argv[2], (std::string**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vector_string_t_resize__SWIG_1(self, argc, argv);
+          return _wrap_vector_string_T_resize__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_t_resize'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_T_resize'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::string >::resize(std::vector< std::string >::size_type)\n"
     "    std::vector< std::string >::resize(std::vector< std::string >::size_type,std::vector< std::string >::value_type const &)\n");
@@ -20929,7 +20929,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::iterator arg2 ;
@@ -20945,28 +20945,28 @@ SWIGINTERN PyObject *_wrap_vector_string_t_insert__SWIG_0(PyObject *self, Py_ssi
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_insert" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_insert" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t_insert" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T_insert" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::string >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::string >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t_insert" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T_insert" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
     }
   }
   {
     std::string *ptr = (std::string *)0;
     res3 = SWIG_AsPtr_std_string(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_string_t_insert" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_string_T_insert" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_t_insert" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_T_insert" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -20981,7 +20981,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::iterator arg2 ;
@@ -20999,33 +20999,33 @@ SWIGINTERN PyObject *_wrap_vector_string_t_insert__SWIG_1(PyObject *self, Py_ssi
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_insert" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_insert" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t_insert" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T_insert" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::string >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::string >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t_insert" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T_insert" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_size_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_string_t_insert" "', argument " "3"" of type '" "std::vector< std::string >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_string_T_insert" "', argument " "3"" of type '" "std::vector< std::string >::size_type""'");
   } 
   arg3 = static_cast< std::vector< std::string >::size_type >(val3);
   {
     std::string *ptr = (std::string *)0;
     res4 = SWIG_AsPtr_std_string(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_string_t_insert" "', argument " "4"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_string_T_insert" "', argument " "4"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_t_insert" "', argument " "4"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_T_insert" "', argument " "4"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     arg4 = ptr;
   }
@@ -21039,13 +21039,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_insert(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_insert(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_t_insert", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_T_insert", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -21059,7 +21059,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_insert(PyObject *self, PyObject *args
         int res = SWIG_AsPtr_std_string(argv[2], (std::string**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vector_string_t_insert__SWIG_0(self, argc, argv);
+          return _wrap_vector_string_T_insert__SWIG_0(self, argc, argv);
         }
       }
     }
@@ -21081,7 +21081,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_insert(PyObject *self, PyObject *args
           int res = SWIG_AsPtr_std_string(argv[3], (std::string**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vector_string_t_insert__SWIG_1(self, argc, argv);
+            return _wrap_vector_string_T_insert__SWIG_1(self, argc, argv);
           }
         }
       }
@@ -21089,7 +21089,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_insert(PyObject *self, PyObject *args
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_t_insert'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_T_insert'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::string >::insert(std::vector< std::string >::iterator,std::vector< std::string >::value_type const &)\n"
     "    std::vector< std::string >::insert(std::vector< std::string >::iterator,std::vector< std::string >::size_type,std::vector< std::string >::value_type const &)\n");
@@ -21097,7 +21097,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_reserve(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_reserve(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::size_type arg2 ;
@@ -21108,15 +21108,15 @@ SWIGINTERN PyObject *_wrap_vector_string_t_reserve(PyObject *self, PyObject *arg
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_string_t_reserve", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_string_T_reserve", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_reserve" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_reserve" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_t_reserve" "', argument " "2"" of type '" "std::vector< std::string >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_T_reserve" "', argument " "2"" of type '" "std::vector< std::string >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::string >::size_type >(val2);
   (arg1)->reserve(arg2);
@@ -21127,7 +21127,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_capacity(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_capacity(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -21140,7 +21140,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_capacity(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_capacity" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_capacity" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = ((std::vector< std::string > const *)arg1)->capacity();
@@ -21151,7 +21151,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_delete_vector_string_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_delete_vector_string_T(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -21163,7 +21163,7 @@ SWIGINTERN PyObject *_wrap_delete_vector_string_t(PyObject *self, PyObject *args
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, SWIG_POINTER_DISOWN |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vector_string_t" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vector_string_T" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   {
@@ -21184,18 +21184,18 @@ fail:
 }
 
 
-SWIGINTERN PyObject *vector_string_t_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vector_string_T_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   PyObject *obj;
   if (!SWIG_Python_UnpackTuple(args, "swigregister", 1, 1, &obj)) return NULL;
   SWIG_TypeNewClientData(SWIGTYPE_p_std__vectorT_std__string_t, SWIG_NewClientData(obj));
   return SWIG_Py_Void();
 }
 
-SWIGINTERN PyObject *vector_string_t_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vector_string_T_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   return SWIG_Python_InitShadowInstance(args);
 }
 
-SWIGINTERN PyObject *_wrap_new_map_string_double_t__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_map_string_double_T__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::less< std::string > *arg1 = 0 ;
   void *argp1 = 0 ;
@@ -21206,10 +21206,10 @@ SWIGINTERN PyObject *_wrap_new_map_string_double_t__SWIG_0(PyObject *self, Py_ss
   if ((nobjs < 1) || (nobjs > 1)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1, SWIGTYPE_p_std__lessT_std__string_t,  0  | 0);
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_map_string_double_t" "', argument " "1"" of type '" "std::less< std::string > const &""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_map_string_double_T" "', argument " "1"" of type '" "std::less< std::string > const &""'"); 
   }
   if (!argp1) {
-    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_map_string_double_t" "', argument " "1"" of type '" "std::less< std::string > const &""'"); 
+    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_map_string_double_T" "', argument " "1"" of type '" "std::less< std::string > const &""'"); 
   }
   arg1 = reinterpret_cast< std::less< std::string > * >(argp1);
   result = (std::map< std::string,double > *)new std::map< std::string,double >((std::less< std::string > const &)*arg1);
@@ -21220,7 +21220,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_iterator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_iterator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   PyObject **arg2 = (PyObject **) 0 ;
@@ -21235,7 +21235,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_iterator(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_iterator" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_iterator" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (swig::SwigPyIterator *)std_map_Sl_std_string_Sc_double_Sg__iterator(arg1,arg2);
@@ -21246,7 +21246,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t___nonzero__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T___nonzero__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -21259,7 +21259,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t___nonzero__(PyObject *self, PyObj
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t___nonzero__" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T___nonzero__" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (bool)std_map_Sl_std_string_Sc_double_Sg____nonzero__((std::map< std::string,double > const *)arg1);
@@ -21270,7 +21270,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t___bool__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T___bool__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -21283,7 +21283,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t___bool__(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t___bool__" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T___bool__" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (bool)std_map_Sl_std_string_Sc_double_Sg____bool__((std::map< std::string,double > const *)arg1);
@@ -21294,7 +21294,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t___len__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T___len__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -21307,7 +21307,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t___len__(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t___len__" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T___len__" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = std_map_Sl_std_string_Sc_double_Sg____len__((std::map< std::string,double > const *)arg1);
@@ -21318,7 +21318,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t___getitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T___getitem__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::key_type *arg2 = 0 ;
@@ -21329,20 +21329,20 @@ SWIGINTERN PyObject *_wrap_map_string_double_t___getitem__(PyObject *self, PyObj
   std::map< std::string,double >::mapped_type *result = 0 ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "map_string_double_t___getitem__", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "map_string_double_T___getitem__", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t___getitem__" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T___getitem__" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t___getitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T___getitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t___getitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T___getitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -21360,7 +21360,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t___delitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T___delitem__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::key_type *arg2 = 0 ;
@@ -21370,20 +21370,20 @@ SWIGINTERN PyObject *_wrap_map_string_double_t___delitem__(PyObject *self, PyObj
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "map_string_double_t___delitem__", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "map_string_double_T___delitem__", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t___delitem__" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T___delitem__" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t___delitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T___delitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t___delitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T___delitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -21401,7 +21401,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_has_key(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_has_key(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::key_type *arg2 = 0 ;
@@ -21412,20 +21412,20 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_has_key(PyObject *self, PyObject
   bool result;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "map_string_double_t_has_key", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "map_string_double_T_has_key", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_has_key" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_has_key" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t_has_key" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T_has_key" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t_has_key" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T_has_key" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -21439,7 +21439,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_keys(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_keys(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -21452,7 +21452,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_keys(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_keys" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_keys" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (PyObject *)std_map_Sl_std_string_Sc_double_Sg__keys(arg1);
@@ -21463,7 +21463,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_values(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_values(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -21476,7 +21476,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_values(PyObject *self, PyObject *
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_values" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_values" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (PyObject *)std_map_Sl_std_string_Sc_double_Sg__values(arg1);
@@ -21487,7 +21487,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_items(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_items(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -21500,7 +21500,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_items(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_items" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_items" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (PyObject *)std_map_Sl_std_string_Sc_double_Sg__items(arg1);
@@ -21511,7 +21511,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t___contains__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T___contains__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::key_type *arg2 = 0 ;
@@ -21522,20 +21522,20 @@ SWIGINTERN PyObject *_wrap_map_string_double_t___contains__(PyObject *self, PyOb
   bool result;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "map_string_double_t___contains__", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "map_string_double_T___contains__", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t___contains__" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T___contains__" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t___contains__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T___contains__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t___contains__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T___contains__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -21549,7 +21549,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_key_iterator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_key_iterator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   PyObject **arg2 = (PyObject **) 0 ;
@@ -21564,7 +21564,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_key_iterator(PyObject *self, PyOb
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_key_iterator" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_key_iterator" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (swig::SwigPyIterator *)std_map_Sl_std_string_Sc_double_Sg__key_iterator(arg1,arg2);
@@ -21575,7 +21575,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_value_iterator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_value_iterator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   PyObject **arg2 = (PyObject **) 0 ;
@@ -21590,7 +21590,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_value_iterator(PyObject *self, Py
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_value_iterator" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_value_iterator" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (swig::SwigPyIterator *)std_map_Sl_std_string_Sc_double_Sg__value_iterator(arg1,arg2);
@@ -21601,7 +21601,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_map_string_double_T___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::key_type *arg2 = 0 ;
@@ -21613,17 +21613,17 @@ SWIGINTERN PyObject *_wrap_map_string_double_t___setitem____SWIG_0(PyObject *sel
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t___setitem__" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T___setitem__" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t___setitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T___setitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t___setitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T___setitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -21637,7 +21637,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_map_string_double_T___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::key_type *arg2 = 0 ;
@@ -21653,23 +21653,23 @@ SWIGINTERN PyObject *_wrap_map_string_double_t___setitem____SWIG_1(PyObject *sel
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t___setitem__" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T___setitem__" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t___setitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T___setitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t___setitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T___setitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     arg2 = ptr;
   }
   ecode3 = SWIG_AsVal_double(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "map_string_double_t___setitem__" "', argument " "3"" of type '" "std::map< std::string,double >::mapped_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "map_string_double_T___setitem__" "', argument " "3"" of type '" "std::map< std::string,double >::mapped_type""'");
   } 
   temp3 = static_cast< std::map< std::string,double >::mapped_type >(val3);
   arg3 = &temp3;
@@ -21687,13 +21687,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t___setitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T___setitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "map_string_double_t___setitem__", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "map_string_double_T___setitem__", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -21703,7 +21703,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t___setitem__(PyObject *self, PyObj
       int res = SWIG_AsPtr_std_string(argv[1], (std::string**)(0));
       _v = SWIG_CheckState(res);
       if (_v) {
-        return _wrap_map_string_double_t___setitem____SWIG_0(self, argc, argv);
+        return _wrap_map_string_double_T___setitem____SWIG_0(self, argc, argv);
       }
     }
   }
@@ -21720,14 +21720,14 @@ SWIGINTERN PyObject *_wrap_map_string_double_t___setitem__(PyObject *self, PyObj
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_map_string_double_t___setitem____SWIG_1(self, argc, argv);
+          return _wrap_map_string_double_T___setitem____SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'map_string_double_t___setitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'map_string_double_T___setitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::map< std::string,double >::__setitem__(std::map< std::string,double >::key_type const &)\n"
     "    std::map< std::string,double >::__setitem__(std::map< std::string,double >::key_type const &,std::map< std::string,double >::mapped_type const &)\n");
@@ -21735,7 +21735,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_asdict(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_asdict(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -21748,7 +21748,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_asdict(PyObject *self, PyObject *
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_asdict" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_asdict" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (PyObject *)std_map_Sl_std_string_Sc_double_Sg__asdict(arg1);
@@ -21759,7 +21759,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_map_string_double_t__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
+SWIGINTERN PyObject *_wrap_new_map_string_double_T__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *result = 0 ;
   
@@ -21773,7 +21773,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_map_string_double_t__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_map_string_double_T__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = 0 ;
   int res1 = SWIG_OLDOBJ ;
@@ -21785,10 +21785,10 @@ SWIGINTERN PyObject *_wrap_new_map_string_double_t__SWIG_2(PyObject *self, Py_ss
     std::map< std::string,double,std::less< std::string >,std::allocator< std::pair< std::string const,double > > > *ptr = (std::map< std::string,double,std::less< std::string >,std::allocator< std::pair< std::string const,double > > > *)0;
     res1 = swig::asptr(swig_obj[0], &ptr);
     if (!SWIG_IsOK(res1)) {
-      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_map_string_double_t" "', argument " "1"" of type '" "std::map< std::string,double > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_map_string_double_T" "', argument " "1"" of type '" "std::map< std::string,double > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_map_string_double_t" "', argument " "1"" of type '" "std::map< std::string,double > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_map_string_double_T" "', argument " "1"" of type '" "std::map< std::string,double > const &""'"); 
     }
     arg1 = ptr;
   }
@@ -21802,23 +21802,23 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_map_string_double_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_new_map_string_double_T(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[2] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "new_map_string_double_t", 0, 1, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "new_map_string_double_T", 0, 1, argv))) SWIG_fail;
   --argc;
   if (argc == 0) {
-    return _wrap_new_map_string_double_t__SWIG_1(self, argc, argv);
+    return _wrap_new_map_string_double_T__SWIG_1(self, argc, argv);
   }
   if (argc == 1) {
     int _v = 0;
     int res = SWIG_ConvertPtr(argv[0], 0, SWIGTYPE_p_std__lessT_std__string_t, SWIG_POINTER_NO_NULL | 0);
     _v = SWIG_CheckState(res);
     if (_v) {
-      return _wrap_new_map_string_double_t__SWIG_0(self, argc, argv);
+      return _wrap_new_map_string_double_T__SWIG_0(self, argc, argv);
     }
   }
   if (argc == 1) {
@@ -21826,12 +21826,12 @@ SWIGINTERN PyObject *_wrap_new_map_string_double_t(PyObject *self, PyObject *arg
     int res = swig::asptr(argv[0], (std::map< std::string,double,std::less< std::string >,std::allocator< std::pair< std::string const,double > > >**)(0));
     _v = SWIG_CheckState(res);
     if (_v) {
-      return _wrap_new_map_string_double_t__SWIG_2(self, argc, argv);
+      return _wrap_new_map_string_double_T__SWIG_2(self, argc, argv);
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_map_string_double_t'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_map_string_double_T'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::map< std::string,double >::map(std::less< std::string > const &)\n"
     "    std::map< std::string,double >::map()\n"
@@ -21840,7 +21840,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_empty(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_empty(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -21853,7 +21853,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_empty(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_empty" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_empty" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (bool)((std::map< std::string,double > const *)arg1)->empty();
@@ -21864,7 +21864,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_size(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_size(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -21877,7 +21877,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_size(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_size" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_size" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = ((std::map< std::string,double > const *)arg1)->size();
@@ -21888,7 +21888,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_swap(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_swap(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double > *arg2 = 0 ;
@@ -21899,18 +21899,18 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_swap(PyObject *self, PyObject *ar
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "map_string_double_t_swap", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "map_string_double_T_swap", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_swap" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_swap" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], &argp2, SWIGTYPE_p_std__mapT_std__string_double_t,  0 );
   if (!SWIG_IsOK(res2)) {
-    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t_swap" "', argument " "2"" of type '" "std::map< std::string,double > &""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T_swap" "', argument " "2"" of type '" "std::map< std::string,double > &""'"); 
   }
   if (!argp2) {
-    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t_swap" "', argument " "2"" of type '" "std::map< std::string,double > &""'"); 
+    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T_swap" "', argument " "2"" of type '" "std::map< std::string,double > &""'"); 
   }
   arg2 = reinterpret_cast< std::map< std::string,double > * >(argp2);
   (arg1)->swap(*arg2);
@@ -21921,7 +21921,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_begin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_begin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -21934,7 +21934,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_begin(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_begin" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_begin" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (arg1)->begin();
@@ -21946,7 +21946,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_end(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_end(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -21959,7 +21959,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_end(PyObject *self, PyObject *arg
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_end" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_end" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (arg1)->end();
@@ -21971,7 +21971,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_rbegin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_rbegin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -21984,7 +21984,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_rbegin(PyObject *self, PyObject *
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_rbegin" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_rbegin" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (arg1)->rbegin();
@@ -21996,7 +21996,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_rend(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_rend(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -22009,7 +22009,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_rend(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_rend" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_rend" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (arg1)->rend();
@@ -22021,7 +22021,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_clear(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_clear(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -22033,7 +22033,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_clear(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_clear" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_clear" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   (arg1)->clear();
@@ -22044,7 +22044,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_get_allocator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_get_allocator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -22057,7 +22057,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_get_allocator(PyObject *self, PyO
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_get_allocator" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_get_allocator" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = ((std::map< std::string,double > const *)arg1)->get_allocator();
@@ -22068,7 +22068,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::key_type *arg2 = 0 ;
@@ -22081,17 +22081,17 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_erase__SWIG_0(PyObject *self, Py_
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_erase" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_erase" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t_erase" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T_erase" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t_erase" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T_erase" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -22105,7 +22105,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_count(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_count(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::key_type *arg2 = 0 ;
@@ -22116,20 +22116,20 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_count(PyObject *self, PyObject *a
   std::map< std::string,double >::size_type result;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "map_string_double_t_count", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "map_string_double_T_count", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_count" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_count" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t_count" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T_count" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t_count" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T_count" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -22143,7 +22143,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::iterator arg2 ;
@@ -22156,18 +22156,18 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_erase__SWIG_1(PyObject *self, Py_
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_erase" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_erase" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_t_erase" "', argument " "2"" of type '" "std::map< std::string,double >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_T_erase" "', argument " "2"" of type '" "std::map< std::string,double >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::map< std::string,double >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::map< std::string,double >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_t_erase" "', argument " "2"" of type '" "std::map< std::string,double >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_T_erase" "', argument " "2"" of type '" "std::map< std::string,double >::iterator""'");
     }
   }
   std_map_Sl_std_string_Sc_double_Sg__erase__SWIG_1(arg1,SWIG_STD_MOVE(arg2));
@@ -22178,7 +22178,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_erase__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_erase__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::iterator arg2 ;
@@ -22194,29 +22194,29 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_erase__SWIG_2(PyObject *self, Py_
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_erase" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_erase" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_t_erase" "', argument " "2"" of type '" "std::map< std::string,double >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_T_erase" "', argument " "2"" of type '" "std::map< std::string,double >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::map< std::string,double >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::map< std::string,double >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_t_erase" "', argument " "2"" of type '" "std::map< std::string,double >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_T_erase" "', argument " "2"" of type '" "std::map< std::string,double >::iterator""'");
     }
   }
   res3 = SWIG_ConvertPtr(swig_obj[2], SWIG_as_voidptrptr(&iter3), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res3) || !iter3) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_t_erase" "', argument " "3"" of type '" "std::map< std::string,double >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_T_erase" "', argument " "3"" of type '" "std::map< std::string,double >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::map< std::string,double >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::map< std::string,double >::iterator > *>(iter3);
     if (iter_t) {
       arg3 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_t_erase" "', argument " "3"" of type '" "std::map< std::string,double >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_T_erase" "', argument " "3"" of type '" "std::map< std::string,double >::iterator""'");
     }
   }
   std_map_Sl_std_string_Sc_double_Sg__erase__SWIG_2(arg1,SWIG_STD_MOVE(arg2),SWIG_STD_MOVE(arg3));
@@ -22227,13 +22227,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_erase(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_erase(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "map_string_double_t_erase", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "map_string_double_T_erase", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -22244,7 +22244,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_erase(PyObject *self, PyObject *a
       int res = SWIG_ConvertPtr(argv[1], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
       _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::map< std::string,double >::iterator > *>(iter) != 0));
       if (_v) {
-        return _wrap_map_string_double_t_erase__SWIG_1(self, argc, argv);
+        return _wrap_map_string_double_T_erase__SWIG_1(self, argc, argv);
       }
     }
   }
@@ -22256,7 +22256,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_erase(PyObject *self, PyObject *a
       int res = SWIG_AsPtr_std_string(argv[1], (std::string**)(0));
       _v = SWIG_CheckState(res);
       if (_v) {
-        return _wrap_map_string_double_t_erase__SWIG_0(self, argc, argv);
+        return _wrap_map_string_double_T_erase__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -22273,14 +22273,14 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_erase(PyObject *self, PyObject *a
         int res = SWIG_ConvertPtr(argv[2], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
         _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::map< std::string,double >::iterator > *>(iter) != 0));
         if (_v) {
-          return _wrap_map_string_double_t_erase__SWIG_2(self, argc, argv);
+          return _wrap_map_string_double_T_erase__SWIG_2(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'map_string_double_t_erase'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'map_string_double_T_erase'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::map< std::string,double >::erase(std::map< std::string,double >::key_type const &)\n"
     "    std::map< std::string,double >::erase(std::map< std::string,double >::iterator)\n"
@@ -22289,7 +22289,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_find(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_find(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::key_type *arg2 = 0 ;
@@ -22300,20 +22300,20 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_find(PyObject *self, PyObject *ar
   std::map< std::string,double >::iterator result;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "map_string_double_t_find", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "map_string_double_T_find", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_find" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_find" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t_find" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T_find" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t_find" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T_find" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -22328,7 +22328,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_lower_bound(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_lower_bound(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::key_type *arg2 = 0 ;
@@ -22339,20 +22339,20 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_lower_bound(PyObject *self, PyObj
   std::map< std::string,double >::iterator result;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "map_string_double_t_lower_bound", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "map_string_double_T_lower_bound", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_lower_bound" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_lower_bound" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t_lower_bound" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T_lower_bound" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t_lower_bound" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T_lower_bound" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -22367,7 +22367,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_upper_bound(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_upper_bound(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::key_type *arg2 = 0 ;
@@ -22378,20 +22378,20 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_upper_bound(PyObject *self, PyObj
   std::map< std::string,double >::iterator result;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "map_string_double_t_upper_bound", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "map_string_double_T_upper_bound", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_upper_bound" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_upper_bound" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t_upper_bound" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T_upper_bound" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t_upper_bound" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T_upper_bound" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -22406,7 +22406,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_delete_map_string_double_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_delete_map_string_double_T(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -22418,7 +22418,7 @@ SWIGINTERN PyObject *_wrap_delete_map_string_double_t(PyObject *self, PyObject *
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, SWIG_POINTER_DISOWN |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_map_string_double_t" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_map_string_double_T" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
@@ -22439,18 +22439,18 @@ fail:
 }
 
 
-SWIGINTERN PyObject *map_string_double_t_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *map_string_double_T_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   PyObject *obj;
   if (!SWIG_Python_UnpackTuple(args, "swigregister", 1, 1, &obj)) return NULL;
   SWIG_TypeNewClientData(SWIGTYPE_p_std__mapT_std__string_double_t, SWIG_NewClientData(obj));
   return SWIG_Py_Void();
 }
 
-SWIGINTERN PyObject *map_string_double_t_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *map_string_double_T_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   return SWIG_Python_InitShadowInstance(args);
 }
 
-SWIGINTERN PyObject *_wrap_new_pvacuum_double_t__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
+SWIGINTERN PyObject *_wrap_new_pvacuum_double_T__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
   PyObject *resultobj = 0;
   std::pair< double,double > *result = 0 ;
   
@@ -22464,7 +22464,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_pvacuum_double_t__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_pvacuum_double_T__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   double arg1 ;
   double arg2 ;
@@ -22478,12 +22478,12 @@ SWIGINTERN PyObject *_wrap_new_pvacuum_double_t__SWIG_1(PyObject *self, Py_ssize
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   ecode1 = SWIG_AsVal_double(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_pvacuum_double_t" "', argument " "1"" of type '" "double""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_pvacuum_double_T" "', argument " "1"" of type '" "double""'");
   } 
   arg1 = static_cast< double >(val1);
   ecode2 = SWIG_AsVal_double(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "new_pvacuum_double_t" "', argument " "2"" of type '" "double""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "new_pvacuum_double_T" "', argument " "2"" of type '" "double""'");
   } 
   arg2 = static_cast< double >(val2);
   result = (std::pair< double,double > *)new std::pair< double,double >(arg1,arg2);
@@ -22494,7 +22494,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_pvacuum_double_t__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_pvacuum_double_T__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::pair< double,double > *arg1 = 0 ;
   int res1 = SWIG_OLDOBJ ;
@@ -22506,10 +22506,10 @@ SWIGINTERN PyObject *_wrap_new_pvacuum_double_t__SWIG_2(PyObject *self, Py_ssize
     std::pair< double,double > *ptr = (std::pair< double,double > *)0;
     res1 = swig::asptr(swig_obj[0], &ptr);
     if (!SWIG_IsOK(res1)) {
-      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_pvacuum_double_t" "', argument " "1"" of type '" "std::pair< double,double > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_pvacuum_double_T" "', argument " "1"" of type '" "std::pair< double,double > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_pvacuum_double_t" "', argument " "1"" of type '" "std::pair< double,double > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_pvacuum_double_T" "', argument " "1"" of type '" "std::pair< double,double > const &""'"); 
     }
     arg1 = ptr;
   }
@@ -22523,23 +22523,23 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_pvacuum_double_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_new_pvacuum_double_T(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "new_pvacuum_double_t", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "new_pvacuum_double_T", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 0) {
-    return _wrap_new_pvacuum_double_t__SWIG_0(self, argc, argv);
+    return _wrap_new_pvacuum_double_T__SWIG_0(self, argc, argv);
   }
   if (argc == 1) {
     int _v = 0;
     int res = swig::asptr(argv[0], (std::pair< double,double >**)(0));
     _v = SWIG_CheckState(res);
     if (_v) {
-      return _wrap_new_pvacuum_double_t__SWIG_2(self, argc, argv);
+      return _wrap_new_pvacuum_double_T__SWIG_2(self, argc, argv);
     }
   }
   if (argc == 2) {
@@ -22554,13 +22554,13 @@ SWIGINTERN PyObject *_wrap_new_pvacuum_double_t(PyObject *self, PyObject *args)
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_new_pvacuum_double_t__SWIG_1(self, argc, argv);
+        return _wrap_new_pvacuum_double_T__SWIG_1(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_pvacuum_double_t'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_pvacuum_double_T'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::pair< double,double >::pair()\n"
     "    std::pair< double,double >::pair(double,double)\n"
@@ -22569,7 +22569,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_pvacuum_double_t_first_set(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_pvacuum_double_T_first_set(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::pair< double,double > *arg1 = (std::pair< double,double > *) 0 ;
   double arg2 ;
@@ -22580,15 +22580,15 @@ SWIGINTERN PyObject *_wrap_pvacuum_double_t_first_set(PyObject *self, PyObject *
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "pvacuum_double_t_first_set", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "pvacuum_double_T_first_set", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__pairT_double_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "pvacuum_double_t_first_set" "', argument " "1"" of type '" "std::pair< double,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "pvacuum_double_T_first_set" "', argument " "1"" of type '" "std::pair< double,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::pair< double,double > * >(argp1);
   ecode2 = SWIG_AsVal_double(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "pvacuum_double_t_first_set" "', argument " "2"" of type '" "double""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "pvacuum_double_T_first_set" "', argument " "2"" of type '" "double""'");
   } 
   arg2 = static_cast< double >(val2);
   if (arg1) (arg1)->first = arg2;
@@ -22599,7 +22599,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_pvacuum_double_t_first_get(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_pvacuum_double_T_first_get(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::pair< double,double > *arg1 = (std::pair< double,double > *) 0 ;
   void *argp1 = 0 ;
@@ -22612,7 +22612,7 @@ SWIGINTERN PyObject *_wrap_pvacuum_double_t_first_get(PyObject *self, PyObject *
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__pairT_double_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "pvacuum_double_t_first_get" "', argument " "1"" of type '" "std::pair< double,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "pvacuum_double_T_first_get" "', argument " "1"" of type '" "std::pair< double,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::pair< double,double > * >(argp1);
   result = (double) ((arg1)->first);
@@ -22623,7 +22623,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_pvacuum_double_t_second_set(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_pvacuum_double_T_second_set(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::pair< double,double > *arg1 = (std::pair< double,double > *) 0 ;
   double arg2 ;
@@ -22634,15 +22634,15 @@ SWIGINTERN PyObject *_wrap_pvacuum_double_t_second_set(PyObject *self, PyObject
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "pvacuum_double_t_second_set", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "pvacuum_double_T_second_set", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__pairT_double_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "pvacuum_double_t_second_set" "', argument " "1"" of type '" "std::pair< double,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "pvacuum_double_T_second_set" "', argument " "1"" of type '" "std::pair< double,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::pair< double,double > * >(argp1);
   ecode2 = SWIG_AsVal_double(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "pvacuum_double_t_second_set" "', argument " "2"" of type '" "double""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "pvacuum_double_T_second_set" "', argument " "2"" of type '" "double""'");
   } 
   arg2 = static_cast< double >(val2);
   if (arg1) (arg1)->second = arg2;
@@ -22653,7 +22653,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_pvacuum_double_t_second_get(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_pvacuum_double_T_second_get(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::pair< double,double > *arg1 = (std::pair< double,double > *) 0 ;
   void *argp1 = 0 ;
@@ -22666,7 +22666,7 @@ SWIGINTERN PyObject *_wrap_pvacuum_double_t_second_get(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__pairT_double_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "pvacuum_double_t_second_get" "', argument " "1"" of type '" "std::pair< double,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "pvacuum_double_T_second_get" "', argument " "1"" of type '" "std::pair< double,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::pair< double,double > * >(argp1);
   result = (double) ((arg1)->second);
@@ -22677,7 +22677,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_delete_pvacuum_double_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_delete_pvacuum_double_T(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::pair< double,double > *arg1 = (std::pair< double,double > *) 0 ;
   void *argp1 = 0 ;
@@ -22689,7 +22689,7 @@ SWIGINTERN PyObject *_wrap_delete_pvacuum_double_t(PyObject *self, PyObject *arg
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__pairT_double_double_t, SWIG_POINTER_DISOWN |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_pvacuum_double_t" "', argument " "1"" of type '" "std::pair< double,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_pvacuum_double_T" "', argument " "1"" of type '" "std::pair< double,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::pair< double,double > * >(argp1);
   {
@@ -22710,18 +22710,18 @@ fail:
 }
 
 
-SWIGINTERN PyObject *pvacuum_double_t_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *pvacuum_double_T_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   PyObject *obj;
   if (!SWIG_Python_UnpackTuple(args, "swigregister", 1, 1, &obj)) return NULL;
   SWIG_TypeNewClientData(SWIGTYPE_p_std__pairT_double_double_t, SWIG_NewClientData(obj));
   return SWIG_Py_Void();
 }
 
-SWIGINTERN PyObject *pvacuum_double_t_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *pvacuum_double_T_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   return SWIG_Python_InitShadowInstance(args);
 }
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_iterator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_iterator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   PyObject **arg2 = (PyObject **) 0 ;
@@ -22736,7 +22736,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_iterator(PyObject *self, PyOb
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_iterator" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_iterator" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = (swig::SwigPyIterator *)std_vector_Sl_std_pair_Sl_double_Sc_double_Sg__Sg__iterator(arg1,arg2);
@@ -22747,7 +22747,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___nonzero__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___nonzero__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -22760,7 +22760,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___nonzero__(PyObject *self, P
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___nonzero__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___nonzero__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = (bool)std_vector_Sl_std_pair_Sl_double_Sc_double_Sg__Sg____nonzero__((std::vector< std::pair< double,double > > const *)arg1);
@@ -22771,7 +22771,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___bool__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___bool__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -22784,7 +22784,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___bool__(PyObject *self, PyOb
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___bool__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___bool__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = (bool)std_vector_Sl_std_pair_Sl_double_Sc_double_Sg__Sg____bool__((std::vector< std::pair< double,double > > const *)arg1);
@@ -22795,7 +22795,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___len__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___len__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -22808,7 +22808,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___len__(PyObject *self, PyObj
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___len__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___len__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = std_vector_Sl_std_pair_Sl_double_Sc_double_Sg__Sg____len__((std::vector< std::pair< double,double > > const *)arg1);
@@ -22819,7 +22819,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___getslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___getslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::difference_type arg2 ;
@@ -22834,20 +22834,20 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___getslice__(PyObject *self,
   std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > *result = 0 ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t___getslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T___getslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___getslice__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___getslice__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_t___getslice__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_T___getslice__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::pair< double,double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_pvacuum_double_t___getslice__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_pvacuum_double_T___getslice__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::pair< double,double > >::difference_type >(val3);
   try {
@@ -22864,7 +22864,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::difference_type arg2 ;
@@ -22880,17 +22880,17 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setslice____SWIG_0(PyObject
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___setslice__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___setslice__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_t___setslice__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_T___setslice__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::pair< double,double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_pvacuum_double_t___setslice__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_pvacuum_double_T___setslice__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::pair< double,double > >::difference_type >(val3);
   try {
@@ -22907,7 +22907,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::difference_type arg2 ;
@@ -22925,27 +22925,27 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setslice____SWIG_1(PyObject
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___setslice__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___setslice__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_t___setslice__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_T___setslice__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::pair< double,double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_pvacuum_double_t___setslice__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_pvacuum_double_T___setslice__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::pair< double,double > >::difference_type >(val3);
   {
     std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > *ptr = (std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > *)0;
     res4 = swig::asptr(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_pvacuum_double_t___setslice__" "', argument " "4"" of type '" "std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_pvacuum_double_T___setslice__" "', argument " "4"" of type '" "std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_t___setslice__" "', argument " "4"" of type '" "std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_T___setslice__" "', argument " "4"" of type '" "std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > const &""'"); 
     }
     arg4 = ptr;
   }
@@ -22965,13 +22965,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___setslice__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t___setslice__", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T___setslice__", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -22988,7 +22988,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setslice__(PyObject *self,
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_pvacuum_double_t___setslice____SWIG_0(self, argc, argv);
+          return _wrap_vector_pvacuum_double_T___setslice____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -23011,7 +23011,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setslice__(PyObject *self,
           int res = swig::asptr(argv[3], (std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > >**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vector_pvacuum_double_t___setslice____SWIG_1(self, argc, argv);
+            return _wrap_vector_pvacuum_double_T___setslice____SWIG_1(self, argc, argv);
           }
         }
       }
@@ -23019,7 +23019,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setslice__(PyObject *self,
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_t___setslice__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_T___setslice__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::pair< double,double > >::__setslice__(std::vector< std::pair< double,double > >::difference_type,std::vector< std::pair< double,double > >::difference_type)\n"
     "    std::vector< std::pair< double,double > >::__setslice__(std::vector< std::pair< double,double > >::difference_type,std::vector< std::pair< double,double > >::difference_type,std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > const &)\n");
@@ -23027,7 +23027,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___delslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___delslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::difference_type arg2 ;
@@ -23041,20 +23041,20 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___delslice__(PyObject *self,
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t___delslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T___delslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___delslice__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___delslice__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_t___delslice__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_T___delslice__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::pair< double,double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_pvacuum_double_t___delslice__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_pvacuum_double_T___delslice__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::pair< double,double > >::difference_type >(val3);
   try {
@@ -23071,7 +23071,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::difference_type arg2 ;
@@ -23084,12 +23084,12 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___delitem____SWIG_0(PyObject
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___delitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___delitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_t___delitem__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_T___delitem__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::pair< double,double > >::difference_type >(val2);
   try {
@@ -23106,7 +23106,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -23118,12 +23118,12 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___getitem____SWIG_0(PyObject
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___getitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___getitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -23141,7 +23141,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -23154,12 +23154,12 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setitem____SWIG_0(PyObject
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___setitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___setitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -23167,10 +23167,10 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setitem____SWIG_0(PyObject
     std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > *ptr = (std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_pvacuum_double_t___setitem__" "', argument " "3"" of type '" "std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_pvacuum_double_T___setitem__" "', argument " "3"" of type '" "std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_t___setitem__" "', argument " "3"" of type '" "std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_T___setitem__" "', argument " "3"" of type '" "std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > const &""'"); 
     }
     arg3 = ptr;
   }
@@ -23190,7 +23190,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -23201,12 +23201,12 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setitem____SWIG_1(PyObject
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___setitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___setitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -23224,7 +23224,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -23235,12 +23235,12 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___delitem____SWIG_1(PyObject
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___delitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___delitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -23258,13 +23258,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___delitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___delitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t___delitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T___delitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -23275,7 +23275,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___delitem__(PyObject *self, P
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_pvacuum_double_t___delitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_pvacuum_double_T___delitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -23289,13 +23289,13 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___delitem__(PyObject *self, P
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_pvacuum_double_t___delitem____SWIG_0(self, argc, argv);
+        return _wrap_vector_pvacuum_double_T___delitem____SWIG_0(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_t___delitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_T___delitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::pair< double,double > >::__delitem__(std::vector< std::pair< double,double > >::difference_type)\n"
     "    std::vector< std::pair< double,double > >::__delitem__(SWIGPY_SLICEOBJECT *)\n");
@@ -23303,7 +23303,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::difference_type arg2 ;
@@ -23317,12 +23317,12 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___getitem____SWIG_1(PyObject
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___getitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___getitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_t___getitem__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_T___getitem__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::pair< double,double > >::difference_type >(val2);
   try {
@@ -23338,13 +23338,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___getitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___getitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t___getitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T___getitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -23355,7 +23355,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___getitem__(PyObject *self, P
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_pvacuum_double_t___getitem____SWIG_0(self, argc, argv);
+        return _wrap_vector_pvacuum_double_T___getitem____SWIG_0(self, argc, argv);
       }
     }
   }
@@ -23369,13 +23369,13 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___getitem__(PyObject *self, P
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_pvacuum_double_t___getitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_pvacuum_double_T___getitem____SWIG_1(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_t___getitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_T___getitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::pair< double,double > >::__getitem__(SWIGPY_SLICEOBJECT *)\n"
     "    std::vector< std::pair< double,double > >::__getitem__(std::vector< std::pair< double,double > >::difference_type) const\n");
@@ -23383,7 +23383,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::difference_type arg2 ;
@@ -23398,22 +23398,22 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setitem____SWIG_2(PyObject
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___setitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___setitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_t___setitem__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_T___setitem__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::pair< double,double > >::difference_type >(val2);
   {
     std::pair< double,double > *ptr = (std::pair< double,double > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_pvacuum_double_t___setitem__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_pvacuum_double_T___setitem__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_t___setitem__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_T___setitem__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -23431,13 +23431,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___setitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t___setitem__", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T___setitem__", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -23448,7 +23448,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setitem__(PyObject *self, P
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_pvacuum_double_t___setitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_pvacuum_double_T___setitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -23464,7 +23464,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setitem__(PyObject *self, P
         int res = swig::asptr(argv[2], (std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vector_pvacuum_double_t___setitem____SWIG_0(self, argc, argv);
+          return _wrap_vector_pvacuum_double_T___setitem____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -23482,14 +23482,14 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setitem__(PyObject *self, P
         int res = swig::asptr(argv[2], (std::pair< double,double >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vector_pvacuum_double_t___setitem____SWIG_2(self, argc, argv);
+          return _wrap_vector_pvacuum_double_T___setitem____SWIG_2(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_t___setitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_T___setitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::pair< double,double > >::__setitem__(SWIGPY_SLICEOBJECT *,std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > const &)\n"
     "    std::vector< std::pair< double,double > >::__setitem__(SWIGPY_SLICEOBJECT *)\n"
@@ -23498,7 +23498,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_pop(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_pop(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -23511,7 +23511,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_pop(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_pop" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_pop" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   try {
@@ -23526,7 +23526,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_append(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_append(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::value_type *arg2 = 0 ;
@@ -23536,20 +23536,20 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_append(PyObject *self, PyObje
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t_append", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T_append", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_append" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_append" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   {
     std::pair< double,double > *ptr = (std::pair< double,double > *)0;
     res2 = swig::asptr(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_pvacuum_double_t_append" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_pvacuum_double_T_append" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_t_append" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_T_append" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -23563,7 +23563,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_t__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
+SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_T__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *result = 0 ;
   
@@ -23577,7 +23577,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_t__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_T__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = 0 ;
   int res1 = SWIG_OLDOBJ ;
@@ -23589,10 +23589,10 @@ SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_t__SWIG_1(PyObject *self, P
     std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > *ptr = (std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > *)0;
     res1 = swig::asptr(swig_obj[0], &ptr);
     if (!SWIG_IsOK(res1)) {
-      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vector_pvacuum_double_t" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vector_pvacuum_double_T" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_pvacuum_double_t" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_pvacuum_double_T" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const &""'"); 
     }
     arg1 = ptr;
   }
@@ -23606,7 +23606,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_empty(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_empty(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -23619,7 +23619,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_empty(PyObject *self, PyObjec
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_empty" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_empty" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = (bool)((std::vector< std::pair< double,double > > const *)arg1)->empty();
@@ -23630,7 +23630,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_size(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_size(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -23643,7 +23643,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_size(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_size" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_size" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = ((std::vector< std::pair< double,double > > const *)arg1)->size();
@@ -23654,7 +23654,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_swap(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_swap(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > > *arg2 = 0 ;
@@ -23665,18 +23665,18 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_swap(PyObject *self, PyObject
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t_swap", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T_swap", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_swap" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_swap" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], &argp2, SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t,  0 );
   if (!SWIG_IsOK(res2)) {
-    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_pvacuum_double_t_swap" "', argument " "2"" of type '" "std::vector< std::pair< double,double > > &""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_pvacuum_double_T_swap" "', argument " "2"" of type '" "std::vector< std::pair< double,double > > &""'"); 
   }
   if (!argp2) {
-    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_t_swap" "', argument " "2"" of type '" "std::vector< std::pair< double,double > > &""'"); 
+    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_T_swap" "', argument " "2"" of type '" "std::vector< std::pair< double,double > > &""'"); 
   }
   arg2 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp2);
   (arg1)->swap(*arg2);
@@ -23687,7 +23687,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_begin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_begin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -23700,7 +23700,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_begin(PyObject *self, PyObjec
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_begin" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_begin" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = (arg1)->begin();
@@ -23712,7 +23712,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_end(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_end(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -23725,7 +23725,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_end(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_end" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_end" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = (arg1)->end();
@@ -23737,7 +23737,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_rbegin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_rbegin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -23750,7 +23750,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_rbegin(PyObject *self, PyObje
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_rbegin" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_rbegin" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = (arg1)->rbegin();
@@ -23762,7 +23762,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_rend(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_rend(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -23775,7 +23775,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_rend(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_rend" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_rend" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = (arg1)->rend();
@@ -23787,7 +23787,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_clear(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_clear(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -23799,7 +23799,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_clear(PyObject *self, PyObjec
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_clear" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_clear" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   (arg1)->clear();
@@ -23810,7 +23810,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_get_allocator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_get_allocator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -23823,7 +23823,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_get_allocator(PyObject *self,
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_get_allocator" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_get_allocator" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = ((std::vector< std::pair< double,double > > const *)arg1)->get_allocator();
@@ -23834,7 +23834,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_t__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_T__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > >::size_type arg1 ;
   size_t val1 ;
@@ -23845,7 +23845,7 @@ SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_t__SWIG_2(PyObject *self, P
   if ((nobjs < 1) || (nobjs > 1)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_pvacuum_double_t" "', argument " "1"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_pvacuum_double_T" "', argument " "1"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
   } 
   arg1 = static_cast< std::vector< std::pair< double,double > >::size_type >(val1);
   result = (std::vector< std::pair< double,double > > *)new std::vector< std::pair< double,double > >(arg1);
@@ -23856,7 +23856,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_pop_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_pop_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -23868,7 +23868,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_pop_back(PyObject *self, PyOb
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_pop_back" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_pop_back" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   (arg1)->pop_back();
@@ -23879,7 +23879,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::size_type arg2 ;
@@ -23892,12 +23892,12 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_resize__SWIG_0(PyObject *self
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_resize" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_resize" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_t_resize" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_T_resize" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::pair< double,double > >::size_type >(val2);
   (arg1)->resize(arg2);
@@ -23908,7 +23908,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::iterator arg2 ;
@@ -23922,18 +23922,18 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_erase__SWIG_0(PyObject *self,
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_erase" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_erase" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t_erase" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T_erase" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t_erase" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T_erase" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
     }
   }
   result = std_vector_Sl_std_pair_Sl_double_Sc_double_Sg__Sg__erase__SWIG_0(arg1,SWIG_STD_MOVE(arg2));
@@ -23945,7 +23945,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::iterator arg2 ;
@@ -23962,29 +23962,29 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_erase__SWIG_1(PyObject *self,
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_erase" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_erase" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t_erase" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T_erase" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t_erase" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T_erase" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
     }
   }
   res3 = SWIG_ConvertPtr(swig_obj[2], SWIG_as_voidptrptr(&iter3), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res3) || !iter3) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t_erase" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T_erase" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *>(iter3);
     if (iter_t) {
       arg3 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t_erase" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T_erase" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
     }
   }
   result = std_vector_Sl_std_pair_Sl_double_Sc_double_Sg__Sg__erase__SWIG_1(arg1,SWIG_STD_MOVE(arg2),SWIG_STD_MOVE(arg3));
@@ -23996,13 +23996,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_erase(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_erase(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t_erase", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T_erase", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -24013,7 +24013,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_erase(PyObject *self, PyObjec
       int res = SWIG_ConvertPtr(argv[1], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
       _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *>(iter) != 0));
       if (_v) {
-        return _wrap_vector_pvacuum_double_t_erase__SWIG_0(self, argc, argv);
+        return _wrap_vector_pvacuum_double_T_erase__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -24030,14 +24030,14 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_erase(PyObject *self, PyObjec
         int res = SWIG_ConvertPtr(argv[2], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
         _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *>(iter) != 0));
         if (_v) {
-          return _wrap_vector_pvacuum_double_t_erase__SWIG_1(self, argc, argv);
+          return _wrap_vector_pvacuum_double_T_erase__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_t_erase'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_T_erase'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::pair< double,double > >::erase(std::vector< std::pair< double,double > >::iterator)\n"
     "    std::vector< std::pair< double,double > >::erase(std::vector< std::pair< double,double > >::iterator,std::vector< std::pair< double,double > >::iterator)\n");
@@ -24045,7 +24045,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_t__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_T__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > >::size_type arg1 ;
   std::vector< std::pair< double,double > >::value_type *arg2 = 0 ;
@@ -24058,17 +24058,17 @@ SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_t__SWIG_3(PyObject *self, P
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_pvacuum_double_t" "', argument " "1"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_pvacuum_double_T" "', argument " "1"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
   } 
   arg1 = static_cast< std::vector< std::pair< double,double > >::size_type >(val1);
   {
     std::pair< double,double > *ptr = (std::pair< double,double > *)0;
     res2 = swig::asptr(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "new_vector_pvacuum_double_t" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "new_vector_pvacuum_double_T" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_pvacuum_double_t" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_pvacuum_double_T" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -24082,16 +24082,16 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_T(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vector_pvacuum_double_t", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vector_pvacuum_double_T", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 0) {
-    return _wrap_new_vector_pvacuum_double_t__SWIG_0(self, argc, argv);
+    return _wrap_new_vector_pvacuum_double_T__SWIG_0(self, argc, argv);
   }
   if (argc == 1) {
     int _v = 0;
@@ -24100,7 +24100,7 @@ SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_t(PyObject *self, PyObject
       _v = SWIG_CheckState(res);
     }
     if (_v) {
-      return _wrap_new_vector_pvacuum_double_t__SWIG_2(self, argc, argv);
+      return _wrap_new_vector_pvacuum_double_T__SWIG_2(self, argc, argv);
     }
   }
   if (argc == 1) {
@@ -24108,7 +24108,7 @@ SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_t(PyObject *self, PyObject
     int res = swig::asptr(argv[0], (std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > >**)(0));
     _v = SWIG_CheckState(res);
     if (_v) {
-      return _wrap_new_vector_pvacuum_double_t__SWIG_1(self, argc, argv);
+      return _wrap_new_vector_pvacuum_double_T__SWIG_1(self, argc, argv);
     }
   }
   if (argc == 2) {
@@ -24121,13 +24121,13 @@ SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_t(PyObject *self, PyObject
       int res = swig::asptr(argv[1], (std::pair< double,double >**)(0));
       _v = SWIG_CheckState(res);
       if (_v) {
-        return _wrap_new_vector_pvacuum_double_t__SWIG_3(self, argc, argv);
+        return _wrap_new_vector_pvacuum_double_T__SWIG_3(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vector_pvacuum_double_t'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vector_pvacuum_double_T'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::pair< double,double > >::vector()\n"
     "    std::vector< std::pair< double,double > >::vector(std::vector< std::pair< double,double > > const &)\n"
@@ -24137,7 +24137,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_push_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_push_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::value_type *arg2 = 0 ;
@@ -24147,20 +24147,20 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_push_back(PyObject *self, PyO
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t_push_back", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T_push_back", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_push_back" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_push_back" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   {
     std::pair< double,double > *ptr = (std::pair< double,double > *)0;
     res2 = swig::asptr(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_pvacuum_double_t_push_back" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_pvacuum_double_T_push_back" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_t_push_back" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_T_push_back" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -24174,7 +24174,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_front(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_front(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -24187,7 +24187,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_front(PyObject *self, PyObjec
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_front" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_front" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = (std::vector< std::pair< double,double > >::value_type *) &((std::vector< std::pair< double,double > > const *)arg1)->front();
@@ -24199,7 +24199,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -24212,7 +24212,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_back(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_back" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_back" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = (std::vector< std::pair< double,double > >::value_type *) &((std::vector< std::pair< double,double > > const *)arg1)->back();
@@ -24224,7 +24224,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_assign(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_assign(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::size_type arg2 ;
@@ -24237,25 +24237,25 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_assign(PyObject *self, PyObje
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t_assign", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T_assign", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_assign" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_assign" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_t_assign" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_T_assign" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::pair< double,double > >::size_type >(val2);
   {
     std::pair< double,double > *ptr = (std::pair< double,double > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_pvacuum_double_t_assign" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_pvacuum_double_T_assign" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_t_assign" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_T_assign" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -24269,7 +24269,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::size_type arg2 ;
@@ -24284,22 +24284,22 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_resize__SWIG_1(PyObject *self
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_resize" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_resize" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_t_resize" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_T_resize" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::pair< double,double > >::size_type >(val2);
   {
     std::pair< double,double > *ptr = (std::pair< double,double > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_pvacuum_double_t_resize" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_pvacuum_double_T_resize" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_t_resize" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_T_resize" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -24313,13 +24313,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_resize(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_resize(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t_resize", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T_resize", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -24331,7 +24331,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_resize(PyObject *self, PyObje
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_pvacuum_double_t_resize__SWIG_0(self, argc, argv);
+        return _wrap_vector_pvacuum_double_T_resize__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -24348,14 +24348,14 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_resize(PyObject *self, PyObje
         int res = swig::asptr(argv[2], (std::pair< double,double >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vector_pvacuum_double_t_resize__SWIG_1(self, argc, argv);
+          return _wrap_vector_pvacuum_double_T_resize__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_t_resize'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_T_resize'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::pair< double,double > >::resize(std::vector< std::pair< double,double > >::size_type)\n"
     "    std::vector< std::pair< double,double > >::resize(std::vector< std::pair< double,double > >::size_type,std::vector< std::pair< double,double > >::value_type const &)\n");
@@ -24363,7 +24363,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::iterator arg2 ;
@@ -24379,28 +24379,28 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_insert__SWIG_0(PyObject *self
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_insert" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_insert" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t_insert" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T_insert" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t_insert" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T_insert" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
     }
   }
   {
     std::pair< double,double > *ptr = (std::pair< double,double > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_pvacuum_double_t_insert" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_pvacuum_double_T_insert" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_t_insert" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_T_insert" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -24415,7 +24415,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::iterator arg2 ;
@@ -24433,33 +24433,33 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_insert__SWIG_1(PyObject *self
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_insert" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_insert" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t_insert" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T_insert" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t_insert" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T_insert" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_size_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_pvacuum_double_t_insert" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_pvacuum_double_T_insert" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
   } 
   arg3 = static_cast< std::vector< std::pair< double,double > >::size_type >(val3);
   {
     std::pair< double,double > *ptr = (std::pair< double,double > *)0;
     res4 = swig::asptr(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_pvacuum_double_t_insert" "', argument " "4"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_pvacuum_double_T_insert" "', argument " "4"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_t_insert" "', argument " "4"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_T_insert" "', argument " "4"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     arg4 = ptr;
   }
@@ -24473,13 +24473,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_insert(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_insert(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t_insert", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T_insert", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -24493,7 +24493,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_insert(PyObject *self, PyObje
         int res = swig::asptr(argv[2], (std::pair< double,double >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vector_pvacuum_double_t_insert__SWIG_0(self, argc, argv);
+          return _wrap_vector_pvacuum_double_T_insert__SWIG_0(self, argc, argv);
         }
       }
     }
@@ -24515,7 +24515,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_insert(PyObject *self, PyObje
           int res = swig::asptr(argv[3], (std::pair< double,double >**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vector_pvacuum_double_t_insert__SWIG_1(self, argc, argv);
+            return _wrap_vector_pvacuum_double_T_insert__SWIG_1(self, argc, argv);
           }
         }
       }
@@ -24523,7 +24523,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_insert(PyObject *self, PyObje
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_t_insert'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_T_insert'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::pair< double,double > >::insert(std::vector< std::pair< double,double > >::iterator,std::vector< std::pair< double,double > >::value_type const &)\n"
     "    std::vector< std::pair< double,double > >::insert(std::vector< std::pair< double,double > >::iterator,std::vector< std::pair< double,double > >::size_type,std::vector< std::pair< double,double > >::value_type const &)\n");
@@ -24531,7 +24531,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_reserve(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_reserve(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::size_type arg2 ;
@@ -24542,15 +24542,15 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_reserve(PyObject *self, PyObj
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t_reserve", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T_reserve", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_reserve" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_reserve" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_t_reserve" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_T_reserve" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::pair< double,double > >::size_type >(val2);
   (arg1)->reserve(arg2);
@@ -24561,7 +24561,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_capacity(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_capacity(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -24574,7 +24574,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_capacity(PyObject *self, PyOb
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_capacity" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_capacity" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = ((std::vector< std::pair< double,double > > const *)arg1)->capacity();
@@ -24585,7 +24585,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_delete_vector_pvacuum_double_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_delete_vector_pvacuum_double_T(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -24597,7 +24597,7 @@ SWIGINTERN PyObject *_wrap_delete_vector_pvacuum_double_t(PyObject *self, PyObje
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, SWIG_POINTER_DISOWN |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vector_pvacuum_double_t" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vector_pvacuum_double_T" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   {
@@ -24618,14 +24618,14 @@ fail:
 }
 
 
-SWIGINTERN PyObject *vector_pvacuum_double_t_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vector_pvacuum_double_T_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   PyObject *obj;
   if (!SWIG_Python_UnpackTuple(args, "swigregister", 1, 1, &obj)) return NULL;
   SWIG_TypeNewClientData(SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, SWIG_NewClientData(obj));
   return SWIG_Py_Void();
 }
 
-SWIGINTERN PyObject *vector_pvacuum_double_t_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vector_pvacuum_double_T_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   return SWIG_Python_InitShadowInstance(args);
 }
 
@@ -27146,7 +27146,7 @@ SWIGINTERN PyObject *_wrap_Parameters_correlationMatrix(PyObject *self, PyObject
   void *argp1 = 0 ;
   int res1 = 0 ;
   PyObject *swig_obj[1] ;
-  mumufit::Parameters::corr_matrix_t result;
+  double2d_t result;
   
   (void)self;
   if (!args) SWIG_fail;
@@ -27167,7 +27167,7 @@ SWIGINTERN PyObject *_wrap_Parameters_correlationMatrix(PyObject *self, PyObject
       SWIG_exception(SWIG_RuntimeError, msg.c_str());
     }
   }
-  resultobj = swig::from(static_cast< std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > >(result));
+  resultobj = SWIG_NewPointerObj((new double2d_t(result)), SWIGTYPE_p_double2d_t, SWIG_POINTER_OWN |  0 );
   return resultobj;
 fail:
   return NULL;
@@ -27177,10 +27177,11 @@ fail:
 SWIGINTERN PyObject *_wrap_Parameters_setCorrelationMatrix(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   mumufit::Parameters *arg1 = (mumufit::Parameters *) 0 ;
-  mumufit::Parameters::corr_matrix_t *arg2 = 0 ;
+  double2d_t *arg2 = 0 ;
   void *argp1 = 0 ;
   int res1 = 0 ;
-  int res2 = SWIG_OLDOBJ ;
+  void *argp2 = 0 ;
+  int res2 = 0 ;
   PyObject *swig_obj[2] ;
   
   (void)self;
@@ -27190,20 +27191,17 @@ SWIGINTERN PyObject *_wrap_Parameters_setCorrelationMatrix(PyObject *self, PyObj
     SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "Parameters_setCorrelationMatrix" "', argument " "1"" of type '" "mumufit::Parameters *""'"); 
   }
   arg1 = reinterpret_cast< mumufit::Parameters * >(argp1);
-  {
-    std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > *ptr = (std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > *)0;
-    res2 = swig::asptr(swig_obj[1], &ptr);
-    if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "Parameters_setCorrelationMatrix" "', argument " "2"" of type '" "mumufit::Parameters::corr_matrix_t const &""'"); 
-    }
-    if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "Parameters_setCorrelationMatrix" "', argument " "2"" of type '" "mumufit::Parameters::corr_matrix_t const &""'"); 
-    }
-    arg2 = ptr;
+  res2 = SWIG_ConvertPtr(swig_obj[1], &argp2, SWIGTYPE_p_double2d_t,  0  | 0);
+  if (!SWIG_IsOK(res2)) {
+    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "Parameters_setCorrelationMatrix" "', argument " "2"" of type '" "double2d_t const &""'"); 
   }
+  if (!argp2) {
+    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "Parameters_setCorrelationMatrix" "', argument " "2"" of type '" "double2d_t const &""'"); 
+  }
+  arg2 = reinterpret_cast< double2d_t * >(argp2);
   {
     try {
-      (arg1)->setCorrelationMatrix((mumufit::Parameters::corr_matrix_t const &)*arg2);
+      (arg1)->setCorrelationMatrix((double2d_t const &)*arg2);
     } catch (const std::exception& ex) {
       // message shown in the Python interpreter
       const std::string msg {
@@ -27213,10 +27211,8 @@ SWIGINTERN PyObject *_wrap_Parameters_setCorrelationMatrix(PyObject *self, PyObj
     }
   }
   resultobj = SWIG_Py_Void();
-  if (SWIG_IsNewObj(res2)) delete arg2;
   return resultobj;
 fail:
-  if (SWIG_IsNewObj(res2)) delete arg2;
   return NULL;
 }
 
@@ -29426,558 +29422,558 @@ static PyMethodDef SwigMethods[] = {
 		"SwigPyIterator___sub__(SwigPyIterator self, SwigPyIterator x) -> ptrdiff_t\n"
 		""},
 	 { "SwigPyIterator_swigregister", SwigPyIterator_swigregister, METH_O, NULL},
-	 { "vdouble1d_t_iterator", _wrap_vdouble1d_t_iterator, METH_O, "vdouble1d_t_iterator(vdouble1d_t self) -> SwigPyIterator"},
-	 { "vdouble1d_t___nonzero__", _wrap_vdouble1d_t___nonzero__, METH_O, "vdouble1d_t___nonzero__(vdouble1d_t self) -> bool"},
-	 { "vdouble1d_t___bool__", _wrap_vdouble1d_t___bool__, METH_O, "vdouble1d_t___bool__(vdouble1d_t self) -> bool"},
-	 { "vdouble1d_t___len__", _wrap_vdouble1d_t___len__, METH_O, "vdouble1d_t___len__(vdouble1d_t self) -> std::vector< double >::size_type"},
-	 { "vdouble1d_t___getslice__", _wrap_vdouble1d_t___getslice__, METH_VARARGS, "vdouble1d_t___getslice__(vdouble1d_t self, std::vector< double >::difference_type i, std::vector< double >::difference_type j) -> vdouble1d_t"},
-	 { "vdouble1d_t___setslice__", _wrap_vdouble1d_t___setslice__, METH_VARARGS, "\n"
-		"vdouble1d_t___setslice__(vdouble1d_t self, std::vector< double >::difference_type i, std::vector< double >::difference_type j)\n"
-		"vdouble1d_t___setslice__(vdouble1d_t self, std::vector< double >::difference_type i, std::vector< double >::difference_type j, vdouble1d_t v)\n"
+	 { "vdouble1d_T_iterator", _wrap_vdouble1d_T_iterator, METH_O, "vdouble1d_T_iterator(vdouble1d_T self) -> SwigPyIterator"},
+	 { "vdouble1d_T___nonzero__", _wrap_vdouble1d_T___nonzero__, METH_O, "vdouble1d_T___nonzero__(vdouble1d_T self) -> bool"},
+	 { "vdouble1d_T___bool__", _wrap_vdouble1d_T___bool__, METH_O, "vdouble1d_T___bool__(vdouble1d_T self) -> bool"},
+	 { "vdouble1d_T___len__", _wrap_vdouble1d_T___len__, METH_O, "vdouble1d_T___len__(vdouble1d_T self) -> std::vector< double >::size_type"},
+	 { "vdouble1d_T___getslice__", _wrap_vdouble1d_T___getslice__, METH_VARARGS, "vdouble1d_T___getslice__(vdouble1d_T self, std::vector< double >::difference_type i, std::vector< double >::difference_type j) -> vdouble1d_T"},
+	 { "vdouble1d_T___setslice__", _wrap_vdouble1d_T___setslice__, METH_VARARGS, "\n"
+		"vdouble1d_T___setslice__(vdouble1d_T self, std::vector< double >::difference_type i, std::vector< double >::difference_type j)\n"
+		"vdouble1d_T___setslice__(vdouble1d_T self, std::vector< double >::difference_type i, std::vector< double >::difference_type j, vdouble1d_T v)\n"
 		""},
-	 { "vdouble1d_t___delslice__", _wrap_vdouble1d_t___delslice__, METH_VARARGS, "vdouble1d_t___delslice__(vdouble1d_t self, std::vector< double >::difference_type i, std::vector< double >::difference_type j)"},
-	 { "vdouble1d_t___delitem__", _wrap_vdouble1d_t___delitem__, METH_VARARGS, "\n"
-		"vdouble1d_t___delitem__(vdouble1d_t self, std::vector< double >::difference_type i)\n"
-		"vdouble1d_t___delitem__(vdouble1d_t self, SWIGPY_SLICEOBJECT * slice)\n"
+	 { "vdouble1d_T___delslice__", _wrap_vdouble1d_T___delslice__, METH_VARARGS, "vdouble1d_T___delslice__(vdouble1d_T self, std::vector< double >::difference_type i, std::vector< double >::difference_type j)"},
+	 { "vdouble1d_T___delitem__", _wrap_vdouble1d_T___delitem__, METH_VARARGS, "\n"
+		"vdouble1d_T___delitem__(vdouble1d_T self, std::vector< double >::difference_type i)\n"
+		"vdouble1d_T___delitem__(vdouble1d_T self, SWIGPY_SLICEOBJECT * slice)\n"
 		""},
-	 { "vdouble1d_t___getitem__", _wrap_vdouble1d_t___getitem__, METH_VARARGS, "\n"
-		"vdouble1d_t___getitem__(vdouble1d_t self, SWIGPY_SLICEOBJECT * slice) -> vdouble1d_t\n"
-		"vdouble1d_t___getitem__(vdouble1d_t self, std::vector< double >::difference_type i) -> std::vector< double >::value_type const &\n"
+	 { "vdouble1d_T___getitem__", _wrap_vdouble1d_T___getitem__, METH_VARARGS, "\n"
+		"vdouble1d_T___getitem__(vdouble1d_T self, SWIGPY_SLICEOBJECT * slice) -> vdouble1d_T\n"
+		"vdouble1d_T___getitem__(vdouble1d_T self, std::vector< double >::difference_type i) -> std::vector< double >::value_type const &\n"
 		""},
-	 { "vdouble1d_t___setitem__", _wrap_vdouble1d_t___setitem__, METH_VARARGS, "\n"
-		"vdouble1d_t___setitem__(vdouble1d_t self, SWIGPY_SLICEOBJECT * slice, vdouble1d_t v)\n"
-		"vdouble1d_t___setitem__(vdouble1d_t self, SWIGPY_SLICEOBJECT * slice)\n"
-		"vdouble1d_t___setitem__(vdouble1d_t self, std::vector< double >::difference_type i, std::vector< double >::value_type const & x)\n"
+	 { "vdouble1d_T___setitem__", _wrap_vdouble1d_T___setitem__, METH_VARARGS, "\n"
+		"vdouble1d_T___setitem__(vdouble1d_T self, SWIGPY_SLICEOBJECT * slice, vdouble1d_T v)\n"
+		"vdouble1d_T___setitem__(vdouble1d_T self, SWIGPY_SLICEOBJECT * slice)\n"
+		"vdouble1d_T___setitem__(vdouble1d_T self, std::vector< double >::difference_type i, std::vector< double >::value_type const & x)\n"
 		""},
-	 { "vdouble1d_t_pop", _wrap_vdouble1d_t_pop, METH_O, "vdouble1d_t_pop(vdouble1d_t self) -> std::vector< double >::value_type"},
-	 { "vdouble1d_t_append", _wrap_vdouble1d_t_append, METH_VARARGS, "vdouble1d_t_append(vdouble1d_t self, std::vector< double >::value_type const & x)"},
-	 { "vdouble1d_t_empty", _wrap_vdouble1d_t_empty, METH_O, "vdouble1d_t_empty(vdouble1d_t self) -> bool"},
-	 { "vdouble1d_t_size", _wrap_vdouble1d_t_size, METH_O, "vdouble1d_t_size(vdouble1d_t self) -> std::vector< double >::size_type"},
-	 { "vdouble1d_t_swap", _wrap_vdouble1d_t_swap, METH_VARARGS, "vdouble1d_t_swap(vdouble1d_t self, vdouble1d_t v)"},
-	 { "vdouble1d_t_begin", _wrap_vdouble1d_t_begin, METH_O, "vdouble1d_t_begin(vdouble1d_t self) -> std::vector< double >::iterator"},
-	 { "vdouble1d_t_end", _wrap_vdouble1d_t_end, METH_O, "vdouble1d_t_end(vdouble1d_t self) -> std::vector< double >::iterator"},
-	 { "vdouble1d_t_rbegin", _wrap_vdouble1d_t_rbegin, METH_O, "vdouble1d_t_rbegin(vdouble1d_t self) -> std::vector< double >::reverse_iterator"},
-	 { "vdouble1d_t_rend", _wrap_vdouble1d_t_rend, METH_O, "vdouble1d_t_rend(vdouble1d_t self) -> std::vector< double >::reverse_iterator"},
-	 { "vdouble1d_t_clear", _wrap_vdouble1d_t_clear, METH_O, "vdouble1d_t_clear(vdouble1d_t self)"},
-	 { "vdouble1d_t_get_allocator", _wrap_vdouble1d_t_get_allocator, METH_O, "vdouble1d_t_get_allocator(vdouble1d_t self) -> std::vector< double >::allocator_type"},
-	 { "vdouble1d_t_pop_back", _wrap_vdouble1d_t_pop_back, METH_O, "vdouble1d_t_pop_back(vdouble1d_t self)"},
-	 { "vdouble1d_t_erase", _wrap_vdouble1d_t_erase, METH_VARARGS, "\n"
-		"vdouble1d_t_erase(vdouble1d_t self, std::vector< double >::iterator pos) -> std::vector< double >::iterator\n"
-		"vdouble1d_t_erase(vdouble1d_t self, std::vector< double >::iterator first, std::vector< double >::iterator last) -> std::vector< double >::iterator\n"
+	 { "vdouble1d_T_pop", _wrap_vdouble1d_T_pop, METH_O, "vdouble1d_T_pop(vdouble1d_T self) -> std::vector< double >::value_type"},
+	 { "vdouble1d_T_append", _wrap_vdouble1d_T_append, METH_VARARGS, "vdouble1d_T_append(vdouble1d_T self, std::vector< double >::value_type const & x)"},
+	 { "vdouble1d_T_empty", _wrap_vdouble1d_T_empty, METH_O, "vdouble1d_T_empty(vdouble1d_T self) -> bool"},
+	 { "vdouble1d_T_size", _wrap_vdouble1d_T_size, METH_O, "vdouble1d_T_size(vdouble1d_T self) -> std::vector< double >::size_type"},
+	 { "vdouble1d_T_swap", _wrap_vdouble1d_T_swap, METH_VARARGS, "vdouble1d_T_swap(vdouble1d_T self, vdouble1d_T v)"},
+	 { "vdouble1d_T_begin", _wrap_vdouble1d_T_begin, METH_O, "vdouble1d_T_begin(vdouble1d_T self) -> std::vector< double >::iterator"},
+	 { "vdouble1d_T_end", _wrap_vdouble1d_T_end, METH_O, "vdouble1d_T_end(vdouble1d_T self) -> std::vector< double >::iterator"},
+	 { "vdouble1d_T_rbegin", _wrap_vdouble1d_T_rbegin, METH_O, "vdouble1d_T_rbegin(vdouble1d_T self) -> std::vector< double >::reverse_iterator"},
+	 { "vdouble1d_T_rend", _wrap_vdouble1d_T_rend, METH_O, "vdouble1d_T_rend(vdouble1d_T self) -> std::vector< double >::reverse_iterator"},
+	 { "vdouble1d_T_clear", _wrap_vdouble1d_T_clear, METH_O, "vdouble1d_T_clear(vdouble1d_T self)"},
+	 { "vdouble1d_T_get_allocator", _wrap_vdouble1d_T_get_allocator, METH_O, "vdouble1d_T_get_allocator(vdouble1d_T self) -> std::vector< double >::allocator_type"},
+	 { "vdouble1d_T_pop_back", _wrap_vdouble1d_T_pop_back, METH_O, "vdouble1d_T_pop_back(vdouble1d_T self)"},
+	 { "vdouble1d_T_erase", _wrap_vdouble1d_T_erase, METH_VARARGS, "\n"
+		"vdouble1d_T_erase(vdouble1d_T self, std::vector< double >::iterator pos) -> std::vector< double >::iterator\n"
+		"vdouble1d_T_erase(vdouble1d_T self, std::vector< double >::iterator first, std::vector< double >::iterator last) -> std::vector< double >::iterator\n"
 		""},
-	 { "new_vdouble1d_t", _wrap_new_vdouble1d_t, METH_VARARGS, "\n"
-		"vdouble1d_t()\n"
-		"vdouble1d_t(vdouble1d_t other)\n"
-		"vdouble1d_t(std::vector< double >::size_type size)\n"
-		"new_vdouble1d_t(std::vector< double >::size_type size, std::vector< double >::value_type const & value) -> vdouble1d_t\n"
+	 { "new_vdouble1d_T", _wrap_new_vdouble1d_T, METH_VARARGS, "\n"
+		"vdouble1d_T()\n"
+		"vdouble1d_T(vdouble1d_T other)\n"
+		"vdouble1d_T(std::vector< double >::size_type size)\n"
+		"new_vdouble1d_T(std::vector< double >::size_type size, std::vector< double >::value_type const & value) -> vdouble1d_T\n"
 		""},
-	 { "vdouble1d_t_push_back", _wrap_vdouble1d_t_push_back, METH_VARARGS, "vdouble1d_t_push_back(vdouble1d_t self, std::vector< double >::value_type const & x)"},
-	 { "vdouble1d_t_front", _wrap_vdouble1d_t_front, METH_O, "vdouble1d_t_front(vdouble1d_t self) -> std::vector< double >::value_type const &"},
-	 { "vdouble1d_t_back", _wrap_vdouble1d_t_back, METH_O, "vdouble1d_t_back(vdouble1d_t self) -> std::vector< double >::value_type const &"},
-	 { "vdouble1d_t_assign", _wrap_vdouble1d_t_assign, METH_VARARGS, "vdouble1d_t_assign(vdouble1d_t self, std::vector< double >::size_type n, std::vector< double >::value_type const & x)"},
-	 { "vdouble1d_t_resize", _wrap_vdouble1d_t_resize, METH_VARARGS, "\n"
-		"vdouble1d_t_resize(vdouble1d_t self, std::vector< double >::size_type new_size)\n"
-		"vdouble1d_t_resize(vdouble1d_t self, std::vector< double >::size_type new_size, std::vector< double >::value_type const & x)\n"
+	 { "vdouble1d_T_push_back", _wrap_vdouble1d_T_push_back, METH_VARARGS, "vdouble1d_T_push_back(vdouble1d_T self, std::vector< double >::value_type const & x)"},
+	 { "vdouble1d_T_front", _wrap_vdouble1d_T_front, METH_O, "vdouble1d_T_front(vdouble1d_T self) -> std::vector< double >::value_type const &"},
+	 { "vdouble1d_T_back", _wrap_vdouble1d_T_back, METH_O, "vdouble1d_T_back(vdouble1d_T self) -> std::vector< double >::value_type const &"},
+	 { "vdouble1d_T_assign", _wrap_vdouble1d_T_assign, METH_VARARGS, "vdouble1d_T_assign(vdouble1d_T self, std::vector< double >::size_type n, std::vector< double >::value_type const & x)"},
+	 { "vdouble1d_T_resize", _wrap_vdouble1d_T_resize, METH_VARARGS, "\n"
+		"vdouble1d_T_resize(vdouble1d_T self, std::vector< double >::size_type new_size)\n"
+		"vdouble1d_T_resize(vdouble1d_T self, std::vector< double >::size_type new_size, std::vector< double >::value_type const & x)\n"
 		""},
-	 { "vdouble1d_t_insert", _wrap_vdouble1d_t_insert, METH_VARARGS, "\n"
-		"vdouble1d_t_insert(vdouble1d_t self, std::vector< double >::iterator pos, std::vector< double >::value_type const & x) -> std::vector< double >::iterator\n"
-		"vdouble1d_t_insert(vdouble1d_t self, std::vector< double >::iterator pos, std::vector< double >::size_type n, std::vector< double >::value_type const & x)\n"
+	 { "vdouble1d_T_insert", _wrap_vdouble1d_T_insert, METH_VARARGS, "\n"
+		"vdouble1d_T_insert(vdouble1d_T self, std::vector< double >::iterator pos, std::vector< double >::value_type const & x) -> std::vector< double >::iterator\n"
+		"vdouble1d_T_insert(vdouble1d_T self, std::vector< double >::iterator pos, std::vector< double >::size_type n, std::vector< double >::value_type const & x)\n"
 		""},
-	 { "vdouble1d_t_reserve", _wrap_vdouble1d_t_reserve, METH_VARARGS, "vdouble1d_t_reserve(vdouble1d_t self, std::vector< double >::size_type n)"},
-	 { "vdouble1d_t_capacity", _wrap_vdouble1d_t_capacity, METH_O, "vdouble1d_t_capacity(vdouble1d_t self) -> std::vector< double >::size_type"},
-	 { "delete_vdouble1d_t", _wrap_delete_vdouble1d_t, METH_O, "delete_vdouble1d_t(vdouble1d_t self)"},
-	 { "vdouble1d_t_swigregister", vdouble1d_t_swigregister, METH_O, NULL},
-	 { "vdouble1d_t_swiginit", vdouble1d_t_swiginit, METH_VARARGS, NULL},
-	 { "vdouble2d_t_iterator", _wrap_vdouble2d_t_iterator, METH_O, "vdouble2d_t_iterator(vdouble2d_t self) -> SwigPyIterator"},
-	 { "vdouble2d_t___nonzero__", _wrap_vdouble2d_t___nonzero__, METH_O, "vdouble2d_t___nonzero__(vdouble2d_t self) -> bool"},
-	 { "vdouble2d_t___bool__", _wrap_vdouble2d_t___bool__, METH_O, "vdouble2d_t___bool__(vdouble2d_t self) -> bool"},
-	 { "vdouble2d_t___len__", _wrap_vdouble2d_t___len__, METH_O, "vdouble2d_t___len__(vdouble2d_t self) -> std::vector< std::vector< double > >::size_type"},
-	 { "vdouble2d_t___getslice__", _wrap_vdouble2d_t___getslice__, METH_VARARGS, "vdouble2d_t___getslice__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j) -> vdouble2d_t"},
-	 { "vdouble2d_t___setslice__", _wrap_vdouble2d_t___setslice__, METH_VARARGS, "\n"
-		"vdouble2d_t___setslice__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j)\n"
-		"vdouble2d_t___setslice__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j, vdouble2d_t v)\n"
+	 { "vdouble1d_T_reserve", _wrap_vdouble1d_T_reserve, METH_VARARGS, "vdouble1d_T_reserve(vdouble1d_T self, std::vector< double >::size_type n)"},
+	 { "vdouble1d_T_capacity", _wrap_vdouble1d_T_capacity, METH_O, "vdouble1d_T_capacity(vdouble1d_T self) -> std::vector< double >::size_type"},
+	 { "delete_vdouble1d_T", _wrap_delete_vdouble1d_T, METH_O, "delete_vdouble1d_T(vdouble1d_T self)"},
+	 { "vdouble1d_T_swigregister", vdouble1d_T_swigregister, METH_O, NULL},
+	 { "vdouble1d_T_swiginit", vdouble1d_T_swiginit, METH_VARARGS, NULL},
+	 { "vdouble2d_T_iterator", _wrap_vdouble2d_T_iterator, METH_O, "vdouble2d_T_iterator(vdouble2d_T self) -> SwigPyIterator"},
+	 { "vdouble2d_T___nonzero__", _wrap_vdouble2d_T___nonzero__, METH_O, "vdouble2d_T___nonzero__(vdouble2d_T self) -> bool"},
+	 { "vdouble2d_T___bool__", _wrap_vdouble2d_T___bool__, METH_O, "vdouble2d_T___bool__(vdouble2d_T self) -> bool"},
+	 { "vdouble2d_T___len__", _wrap_vdouble2d_T___len__, METH_O, "vdouble2d_T___len__(vdouble2d_T self) -> std::vector< std::vector< double > >::size_type"},
+	 { "vdouble2d_T___getslice__", _wrap_vdouble2d_T___getslice__, METH_VARARGS, "vdouble2d_T___getslice__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j) -> vdouble2d_T"},
+	 { "vdouble2d_T___setslice__", _wrap_vdouble2d_T___setslice__, METH_VARARGS, "\n"
+		"vdouble2d_T___setslice__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j)\n"
+		"vdouble2d_T___setslice__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j, vdouble2d_T v)\n"
 		""},
-	 { "vdouble2d_t___delslice__", _wrap_vdouble2d_t___delslice__, METH_VARARGS, "vdouble2d_t___delslice__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j)"},
-	 { "vdouble2d_t___delitem__", _wrap_vdouble2d_t___delitem__, METH_VARARGS, "\n"
-		"vdouble2d_t___delitem__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i)\n"
-		"vdouble2d_t___delitem__(vdouble2d_t self, SWIGPY_SLICEOBJECT * slice)\n"
+	 { "vdouble2d_T___delslice__", _wrap_vdouble2d_T___delslice__, METH_VARARGS, "vdouble2d_T___delslice__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j)"},
+	 { "vdouble2d_T___delitem__", _wrap_vdouble2d_T___delitem__, METH_VARARGS, "\n"
+		"vdouble2d_T___delitem__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i)\n"
+		"vdouble2d_T___delitem__(vdouble2d_T self, SWIGPY_SLICEOBJECT * slice)\n"
 		""},
-	 { "vdouble2d_t___getitem__", _wrap_vdouble2d_t___getitem__, METH_VARARGS, "\n"
-		"vdouble2d_t___getitem__(vdouble2d_t self, SWIGPY_SLICEOBJECT * slice) -> vdouble2d_t\n"
-		"vdouble2d_t___getitem__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i) -> vdouble1d_t\n"
+	 { "vdouble2d_T___getitem__", _wrap_vdouble2d_T___getitem__, METH_VARARGS, "\n"
+		"vdouble2d_T___getitem__(vdouble2d_T self, SWIGPY_SLICEOBJECT * slice) -> vdouble2d_T\n"
+		"vdouble2d_T___getitem__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i) -> vdouble1d_T\n"
 		""},
-	 { "vdouble2d_t___setitem__", _wrap_vdouble2d_t___setitem__, METH_VARARGS, "\n"
-		"vdouble2d_t___setitem__(vdouble2d_t self, SWIGPY_SLICEOBJECT * slice, vdouble2d_t v)\n"
-		"vdouble2d_t___setitem__(vdouble2d_t self, SWIGPY_SLICEOBJECT * slice)\n"
-		"vdouble2d_t___setitem__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i, vdouble1d_t x)\n"
+	 { "vdouble2d_T___setitem__", _wrap_vdouble2d_T___setitem__, METH_VARARGS, "\n"
+		"vdouble2d_T___setitem__(vdouble2d_T self, SWIGPY_SLICEOBJECT * slice, vdouble2d_T v)\n"
+		"vdouble2d_T___setitem__(vdouble2d_T self, SWIGPY_SLICEOBJECT * slice)\n"
+		"vdouble2d_T___setitem__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i, vdouble1d_T x)\n"
 		""},
-	 { "vdouble2d_t_pop", _wrap_vdouble2d_t_pop, METH_O, "vdouble2d_t_pop(vdouble2d_t self) -> vdouble1d_t"},
-	 { "vdouble2d_t_append", _wrap_vdouble2d_t_append, METH_VARARGS, "vdouble2d_t_append(vdouble2d_t self, vdouble1d_t x)"},
-	 { "vdouble2d_t_empty", _wrap_vdouble2d_t_empty, METH_O, "vdouble2d_t_empty(vdouble2d_t self) -> bool"},
-	 { "vdouble2d_t_size", _wrap_vdouble2d_t_size, METH_O, "vdouble2d_t_size(vdouble2d_t self) -> std::vector< std::vector< double > >::size_type"},
-	 { "vdouble2d_t_swap", _wrap_vdouble2d_t_swap, METH_VARARGS, "vdouble2d_t_swap(vdouble2d_t self, vdouble2d_t v)"},
-	 { "vdouble2d_t_begin", _wrap_vdouble2d_t_begin, METH_O, "vdouble2d_t_begin(vdouble2d_t self) -> std::vector< std::vector< double > >::iterator"},
-	 { "vdouble2d_t_end", _wrap_vdouble2d_t_end, METH_O, "vdouble2d_t_end(vdouble2d_t self) -> std::vector< std::vector< double > >::iterator"},
-	 { "vdouble2d_t_rbegin", _wrap_vdouble2d_t_rbegin, METH_O, "vdouble2d_t_rbegin(vdouble2d_t self) -> std::vector< std::vector< double > >::reverse_iterator"},
-	 { "vdouble2d_t_rend", _wrap_vdouble2d_t_rend, METH_O, "vdouble2d_t_rend(vdouble2d_t self) -> std::vector< std::vector< double > >::reverse_iterator"},
-	 { "vdouble2d_t_clear", _wrap_vdouble2d_t_clear, METH_O, "vdouble2d_t_clear(vdouble2d_t self)"},
-	 { "vdouble2d_t_get_allocator", _wrap_vdouble2d_t_get_allocator, METH_O, "vdouble2d_t_get_allocator(vdouble2d_t self) -> std::vector< std::vector< double > >::allocator_type"},
-	 { "vdouble2d_t_pop_back", _wrap_vdouble2d_t_pop_back, METH_O, "vdouble2d_t_pop_back(vdouble2d_t self)"},
-	 { "vdouble2d_t_erase", _wrap_vdouble2d_t_erase, METH_VARARGS, "\n"
-		"vdouble2d_t_erase(vdouble2d_t self, std::vector< std::vector< double > >::iterator pos) -> std::vector< std::vector< double > >::iterator\n"
-		"vdouble2d_t_erase(vdouble2d_t self, std::vector< std::vector< double > >::iterator first, std::vector< std::vector< double > >::iterator last) -> std::vector< std::vector< double > >::iterator\n"
+	 { "vdouble2d_T_pop", _wrap_vdouble2d_T_pop, METH_O, "vdouble2d_T_pop(vdouble2d_T self) -> vdouble1d_T"},
+	 { "vdouble2d_T_append", _wrap_vdouble2d_T_append, METH_VARARGS, "vdouble2d_T_append(vdouble2d_T self, vdouble1d_T x)"},
+	 { "vdouble2d_T_empty", _wrap_vdouble2d_T_empty, METH_O, "vdouble2d_T_empty(vdouble2d_T self) -> bool"},
+	 { "vdouble2d_T_size", _wrap_vdouble2d_T_size, METH_O, "vdouble2d_T_size(vdouble2d_T self) -> std::vector< std::vector< double > >::size_type"},
+	 { "vdouble2d_T_swap", _wrap_vdouble2d_T_swap, METH_VARARGS, "vdouble2d_T_swap(vdouble2d_T self, vdouble2d_T v)"},
+	 { "vdouble2d_T_begin", _wrap_vdouble2d_T_begin, METH_O, "vdouble2d_T_begin(vdouble2d_T self) -> std::vector< std::vector< double > >::iterator"},
+	 { "vdouble2d_T_end", _wrap_vdouble2d_T_end, METH_O, "vdouble2d_T_end(vdouble2d_T self) -> std::vector< std::vector< double > >::iterator"},
+	 { "vdouble2d_T_rbegin", _wrap_vdouble2d_T_rbegin, METH_O, "vdouble2d_T_rbegin(vdouble2d_T self) -> std::vector< std::vector< double > >::reverse_iterator"},
+	 { "vdouble2d_T_rend", _wrap_vdouble2d_T_rend, METH_O, "vdouble2d_T_rend(vdouble2d_T self) -> std::vector< std::vector< double > >::reverse_iterator"},
+	 { "vdouble2d_T_clear", _wrap_vdouble2d_T_clear, METH_O, "vdouble2d_T_clear(vdouble2d_T self)"},
+	 { "vdouble2d_T_get_allocator", _wrap_vdouble2d_T_get_allocator, METH_O, "vdouble2d_T_get_allocator(vdouble2d_T self) -> std::vector< std::vector< double > >::allocator_type"},
+	 { "vdouble2d_T_pop_back", _wrap_vdouble2d_T_pop_back, METH_O, "vdouble2d_T_pop_back(vdouble2d_T self)"},
+	 { "vdouble2d_T_erase", _wrap_vdouble2d_T_erase, METH_VARARGS, "\n"
+		"vdouble2d_T_erase(vdouble2d_T self, std::vector< std::vector< double > >::iterator pos) -> std::vector< std::vector< double > >::iterator\n"
+		"vdouble2d_T_erase(vdouble2d_T self, std::vector< std::vector< double > >::iterator first, std::vector< std::vector< double > >::iterator last) -> std::vector< std::vector< double > >::iterator\n"
 		""},
-	 { "new_vdouble2d_t", _wrap_new_vdouble2d_t, METH_VARARGS, "\n"
-		"vdouble2d_t()\n"
-		"vdouble2d_t(vdouble2d_t other)\n"
-		"vdouble2d_t(std::vector< std::vector< double > >::size_type size)\n"
-		"new_vdouble2d_t(std::vector< std::vector< double > >::size_type size, vdouble1d_t value) -> vdouble2d_t\n"
+	 { "new_vdouble2d_T", _wrap_new_vdouble2d_T, METH_VARARGS, "\n"
+		"vdouble2d_T()\n"
+		"vdouble2d_T(vdouble2d_T other)\n"
+		"vdouble2d_T(std::vector< std::vector< double > >::size_type size)\n"
+		"new_vdouble2d_T(std::vector< std::vector< double > >::size_type size, vdouble1d_T value) -> vdouble2d_T\n"
 		""},
-	 { "vdouble2d_t_push_back", _wrap_vdouble2d_t_push_back, METH_VARARGS, "vdouble2d_t_push_back(vdouble2d_t self, vdouble1d_t x)"},
-	 { "vdouble2d_t_front", _wrap_vdouble2d_t_front, METH_O, "vdouble2d_t_front(vdouble2d_t self) -> vdouble1d_t"},
-	 { "vdouble2d_t_back", _wrap_vdouble2d_t_back, METH_O, "vdouble2d_t_back(vdouble2d_t self) -> vdouble1d_t"},
-	 { "vdouble2d_t_assign", _wrap_vdouble2d_t_assign, METH_VARARGS, "vdouble2d_t_assign(vdouble2d_t self, std::vector< std::vector< double > >::size_type n, vdouble1d_t x)"},
-	 { "vdouble2d_t_resize", _wrap_vdouble2d_t_resize, METH_VARARGS, "\n"
-		"vdouble2d_t_resize(vdouble2d_t self, std::vector< std::vector< double > >::size_type new_size)\n"
-		"vdouble2d_t_resize(vdouble2d_t self, std::vector< std::vector< double > >::size_type new_size, vdouble1d_t x)\n"
+	 { "vdouble2d_T_push_back", _wrap_vdouble2d_T_push_back, METH_VARARGS, "vdouble2d_T_push_back(vdouble2d_T self, vdouble1d_T x)"},
+	 { "vdouble2d_T_front", _wrap_vdouble2d_T_front, METH_O, "vdouble2d_T_front(vdouble2d_T self) -> vdouble1d_T"},
+	 { "vdouble2d_T_back", _wrap_vdouble2d_T_back, METH_O, "vdouble2d_T_back(vdouble2d_T self) -> vdouble1d_T"},
+	 { "vdouble2d_T_assign", _wrap_vdouble2d_T_assign, METH_VARARGS, "vdouble2d_T_assign(vdouble2d_T self, std::vector< std::vector< double > >::size_type n, vdouble1d_T x)"},
+	 { "vdouble2d_T_resize", _wrap_vdouble2d_T_resize, METH_VARARGS, "\n"
+		"vdouble2d_T_resize(vdouble2d_T self, std::vector< std::vector< double > >::size_type new_size)\n"
+		"vdouble2d_T_resize(vdouble2d_T self, std::vector< std::vector< double > >::size_type new_size, vdouble1d_T x)\n"
 		""},
-	 { "vdouble2d_t_insert", _wrap_vdouble2d_t_insert, METH_VARARGS, "\n"
-		"vdouble2d_t_insert(vdouble2d_t self, std::vector< std::vector< double > >::iterator pos, vdouble1d_t x) -> std::vector< std::vector< double > >::iterator\n"
-		"vdouble2d_t_insert(vdouble2d_t self, std::vector< std::vector< double > >::iterator pos, std::vector< std::vector< double > >::size_type n, vdouble1d_t x)\n"
+	 { "vdouble2d_T_insert", _wrap_vdouble2d_T_insert, METH_VARARGS, "\n"
+		"vdouble2d_T_insert(vdouble2d_T self, std::vector< std::vector< double > >::iterator pos, vdouble1d_T x) -> std::vector< std::vector< double > >::iterator\n"
+		"vdouble2d_T_insert(vdouble2d_T self, std::vector< std::vector< double > >::iterator pos, std::vector< std::vector< double > >::size_type n, vdouble1d_T x)\n"
 		""},
-	 { "vdouble2d_t_reserve", _wrap_vdouble2d_t_reserve, METH_VARARGS, "vdouble2d_t_reserve(vdouble2d_t self, std::vector< std::vector< double > >::size_type n)"},
-	 { "vdouble2d_t_capacity", _wrap_vdouble2d_t_capacity, METH_O, "vdouble2d_t_capacity(vdouble2d_t self) -> std::vector< std::vector< double > >::size_type"},
-	 { "delete_vdouble2d_t", _wrap_delete_vdouble2d_t, METH_O, "delete_vdouble2d_t(vdouble2d_t self)"},
-	 { "vdouble2d_t_swigregister", vdouble2d_t_swigregister, METH_O, NULL},
-	 { "vdouble2d_t_swiginit", vdouble2d_t_swiginit, METH_VARARGS, NULL},
-	 { "vector_integer_t_iterator", _wrap_vector_integer_t_iterator, METH_O, "vector_integer_t_iterator(vector_integer_t self) -> SwigPyIterator"},
-	 { "vector_integer_t___nonzero__", _wrap_vector_integer_t___nonzero__, METH_O, "vector_integer_t___nonzero__(vector_integer_t self) -> bool"},
-	 { "vector_integer_t___bool__", _wrap_vector_integer_t___bool__, METH_O, "vector_integer_t___bool__(vector_integer_t self) -> bool"},
-	 { "vector_integer_t___len__", _wrap_vector_integer_t___len__, METH_O, "vector_integer_t___len__(vector_integer_t self) -> std::vector< int >::size_type"},
-	 { "vector_integer_t___getslice__", _wrap_vector_integer_t___getslice__, METH_VARARGS, "vector_integer_t___getslice__(vector_integer_t self, std::vector< int >::difference_type i, std::vector< int >::difference_type j) -> vector_integer_t"},
-	 { "vector_integer_t___setslice__", _wrap_vector_integer_t___setslice__, METH_VARARGS, "\n"
-		"vector_integer_t___setslice__(vector_integer_t self, std::vector< int >::difference_type i, std::vector< int >::difference_type j)\n"
-		"vector_integer_t___setslice__(vector_integer_t self, std::vector< int >::difference_type i, std::vector< int >::difference_type j, vector_integer_t v)\n"
+	 { "vdouble2d_T_reserve", _wrap_vdouble2d_T_reserve, METH_VARARGS, "vdouble2d_T_reserve(vdouble2d_T self, std::vector< std::vector< double > >::size_type n)"},
+	 { "vdouble2d_T_capacity", _wrap_vdouble2d_T_capacity, METH_O, "vdouble2d_T_capacity(vdouble2d_T self) -> std::vector< std::vector< double > >::size_type"},
+	 { "delete_vdouble2d_T", _wrap_delete_vdouble2d_T, METH_O, "delete_vdouble2d_T(vdouble2d_T self)"},
+	 { "vdouble2d_T_swigregister", vdouble2d_T_swigregister, METH_O, NULL},
+	 { "vdouble2d_T_swiginit", vdouble2d_T_swiginit, METH_VARARGS, NULL},
+	 { "vector_integer_T_iterator", _wrap_vector_integer_T_iterator, METH_O, "vector_integer_T_iterator(vector_integer_T self) -> SwigPyIterator"},
+	 { "vector_integer_T___nonzero__", _wrap_vector_integer_T___nonzero__, METH_O, "vector_integer_T___nonzero__(vector_integer_T self) -> bool"},
+	 { "vector_integer_T___bool__", _wrap_vector_integer_T___bool__, METH_O, "vector_integer_T___bool__(vector_integer_T self) -> bool"},
+	 { "vector_integer_T___len__", _wrap_vector_integer_T___len__, METH_O, "vector_integer_T___len__(vector_integer_T self) -> std::vector< int >::size_type"},
+	 { "vector_integer_T___getslice__", _wrap_vector_integer_T___getslice__, METH_VARARGS, "vector_integer_T___getslice__(vector_integer_T self, std::vector< int >::difference_type i, std::vector< int >::difference_type j) -> vector_integer_T"},
+	 { "vector_integer_T___setslice__", _wrap_vector_integer_T___setslice__, METH_VARARGS, "\n"
+		"vector_integer_T___setslice__(vector_integer_T self, std::vector< int >::difference_type i, std::vector< int >::difference_type j)\n"
+		"vector_integer_T___setslice__(vector_integer_T self, std::vector< int >::difference_type i, std::vector< int >::difference_type j, vector_integer_T v)\n"
 		""},
-	 { "vector_integer_t___delslice__", _wrap_vector_integer_t___delslice__, METH_VARARGS, "vector_integer_t___delslice__(vector_integer_t self, std::vector< int >::difference_type i, std::vector< int >::difference_type j)"},
-	 { "vector_integer_t___delitem__", _wrap_vector_integer_t___delitem__, METH_VARARGS, "\n"
-		"vector_integer_t___delitem__(vector_integer_t self, std::vector< int >::difference_type i)\n"
-		"vector_integer_t___delitem__(vector_integer_t self, SWIGPY_SLICEOBJECT * slice)\n"
+	 { "vector_integer_T___delslice__", _wrap_vector_integer_T___delslice__, METH_VARARGS, "vector_integer_T___delslice__(vector_integer_T self, std::vector< int >::difference_type i, std::vector< int >::difference_type j)"},
+	 { "vector_integer_T___delitem__", _wrap_vector_integer_T___delitem__, METH_VARARGS, "\n"
+		"vector_integer_T___delitem__(vector_integer_T self, std::vector< int >::difference_type i)\n"
+		"vector_integer_T___delitem__(vector_integer_T self, SWIGPY_SLICEOBJECT * slice)\n"
 		""},
-	 { "vector_integer_t___getitem__", _wrap_vector_integer_t___getitem__, METH_VARARGS, "\n"
-		"vector_integer_t___getitem__(vector_integer_t self, SWIGPY_SLICEOBJECT * slice) -> vector_integer_t\n"
-		"vector_integer_t___getitem__(vector_integer_t self, std::vector< int >::difference_type i) -> std::vector< int >::value_type const &\n"
+	 { "vector_integer_T___getitem__", _wrap_vector_integer_T___getitem__, METH_VARARGS, "\n"
+		"vector_integer_T___getitem__(vector_integer_T self, SWIGPY_SLICEOBJECT * slice) -> vector_integer_T\n"
+		"vector_integer_T___getitem__(vector_integer_T self, std::vector< int >::difference_type i) -> std::vector< int >::value_type const &\n"
 		""},
-	 { "vector_integer_t___setitem__", _wrap_vector_integer_t___setitem__, METH_VARARGS, "\n"
-		"vector_integer_t___setitem__(vector_integer_t self, SWIGPY_SLICEOBJECT * slice, vector_integer_t v)\n"
-		"vector_integer_t___setitem__(vector_integer_t self, SWIGPY_SLICEOBJECT * slice)\n"
-		"vector_integer_t___setitem__(vector_integer_t self, std::vector< int >::difference_type i, std::vector< int >::value_type const & x)\n"
+	 { "vector_integer_T___setitem__", _wrap_vector_integer_T___setitem__, METH_VARARGS, "\n"
+		"vector_integer_T___setitem__(vector_integer_T self, SWIGPY_SLICEOBJECT * slice, vector_integer_T v)\n"
+		"vector_integer_T___setitem__(vector_integer_T self, SWIGPY_SLICEOBJECT * slice)\n"
+		"vector_integer_T___setitem__(vector_integer_T self, std::vector< int >::difference_type i, std::vector< int >::value_type const & x)\n"
 		""},
-	 { "vector_integer_t_pop", _wrap_vector_integer_t_pop, METH_O, "vector_integer_t_pop(vector_integer_t self) -> std::vector< int >::value_type"},
-	 { "vector_integer_t_append", _wrap_vector_integer_t_append, METH_VARARGS, "vector_integer_t_append(vector_integer_t self, std::vector< int >::value_type const & x)"},
-	 { "vector_integer_t_empty", _wrap_vector_integer_t_empty, METH_O, "vector_integer_t_empty(vector_integer_t self) -> bool"},
-	 { "vector_integer_t_size", _wrap_vector_integer_t_size, METH_O, "vector_integer_t_size(vector_integer_t self) -> std::vector< int >::size_type"},
-	 { "vector_integer_t_swap", _wrap_vector_integer_t_swap, METH_VARARGS, "vector_integer_t_swap(vector_integer_t self, vector_integer_t v)"},
-	 { "vector_integer_t_begin", _wrap_vector_integer_t_begin, METH_O, "vector_integer_t_begin(vector_integer_t self) -> std::vector< int >::iterator"},
-	 { "vector_integer_t_end", _wrap_vector_integer_t_end, METH_O, "vector_integer_t_end(vector_integer_t self) -> std::vector< int >::iterator"},
-	 { "vector_integer_t_rbegin", _wrap_vector_integer_t_rbegin, METH_O, "vector_integer_t_rbegin(vector_integer_t self) -> std::vector< int >::reverse_iterator"},
-	 { "vector_integer_t_rend", _wrap_vector_integer_t_rend, METH_O, "vector_integer_t_rend(vector_integer_t self) -> std::vector< int >::reverse_iterator"},
-	 { "vector_integer_t_clear", _wrap_vector_integer_t_clear, METH_O, "vector_integer_t_clear(vector_integer_t self)"},
-	 { "vector_integer_t_get_allocator", _wrap_vector_integer_t_get_allocator, METH_O, "vector_integer_t_get_allocator(vector_integer_t self) -> std::vector< int >::allocator_type"},
-	 { "vector_integer_t_pop_back", _wrap_vector_integer_t_pop_back, METH_O, "vector_integer_t_pop_back(vector_integer_t self)"},
-	 { "vector_integer_t_erase", _wrap_vector_integer_t_erase, METH_VARARGS, "\n"
-		"vector_integer_t_erase(vector_integer_t self, std::vector< int >::iterator pos) -> std::vector< int >::iterator\n"
-		"vector_integer_t_erase(vector_integer_t self, std::vector< int >::iterator first, std::vector< int >::iterator last) -> std::vector< int >::iterator\n"
+	 { "vector_integer_T_pop", _wrap_vector_integer_T_pop, METH_O, "vector_integer_T_pop(vector_integer_T self) -> std::vector< int >::value_type"},
+	 { "vector_integer_T_append", _wrap_vector_integer_T_append, METH_VARARGS, "vector_integer_T_append(vector_integer_T self, std::vector< int >::value_type const & x)"},
+	 { "vector_integer_T_empty", _wrap_vector_integer_T_empty, METH_O, "vector_integer_T_empty(vector_integer_T self) -> bool"},
+	 { "vector_integer_T_size", _wrap_vector_integer_T_size, METH_O, "vector_integer_T_size(vector_integer_T self) -> std::vector< int >::size_type"},
+	 { "vector_integer_T_swap", _wrap_vector_integer_T_swap, METH_VARARGS, "vector_integer_T_swap(vector_integer_T self, vector_integer_T v)"},
+	 { "vector_integer_T_begin", _wrap_vector_integer_T_begin, METH_O, "vector_integer_T_begin(vector_integer_T self) -> std::vector< int >::iterator"},
+	 { "vector_integer_T_end", _wrap_vector_integer_T_end, METH_O, "vector_integer_T_end(vector_integer_T self) -> std::vector< int >::iterator"},
+	 { "vector_integer_T_rbegin", _wrap_vector_integer_T_rbegin, METH_O, "vector_integer_T_rbegin(vector_integer_T self) -> std::vector< int >::reverse_iterator"},
+	 { "vector_integer_T_rend", _wrap_vector_integer_T_rend, METH_O, "vector_integer_T_rend(vector_integer_T self) -> std::vector< int >::reverse_iterator"},
+	 { "vector_integer_T_clear", _wrap_vector_integer_T_clear, METH_O, "vector_integer_T_clear(vector_integer_T self)"},
+	 { "vector_integer_T_get_allocator", _wrap_vector_integer_T_get_allocator, METH_O, "vector_integer_T_get_allocator(vector_integer_T self) -> std::vector< int >::allocator_type"},
+	 { "vector_integer_T_pop_back", _wrap_vector_integer_T_pop_back, METH_O, "vector_integer_T_pop_back(vector_integer_T self)"},
+	 { "vector_integer_T_erase", _wrap_vector_integer_T_erase, METH_VARARGS, "\n"
+		"vector_integer_T_erase(vector_integer_T self, std::vector< int >::iterator pos) -> std::vector< int >::iterator\n"
+		"vector_integer_T_erase(vector_integer_T self, std::vector< int >::iterator first, std::vector< int >::iterator last) -> std::vector< int >::iterator\n"
 		""},
-	 { "new_vector_integer_t", _wrap_new_vector_integer_t, METH_VARARGS, "\n"
-		"vector_integer_t()\n"
-		"vector_integer_t(vector_integer_t other)\n"
-		"vector_integer_t(std::vector< int >::size_type size)\n"
-		"new_vector_integer_t(std::vector< int >::size_type size, std::vector< int >::value_type const & value) -> vector_integer_t\n"
+	 { "new_vector_integer_T", _wrap_new_vector_integer_T, METH_VARARGS, "\n"
+		"vector_integer_T()\n"
+		"vector_integer_T(vector_integer_T other)\n"
+		"vector_integer_T(std::vector< int >::size_type size)\n"
+		"new_vector_integer_T(std::vector< int >::size_type size, std::vector< int >::value_type const & value) -> vector_integer_T\n"
 		""},
-	 { "vector_integer_t_push_back", _wrap_vector_integer_t_push_back, METH_VARARGS, "vector_integer_t_push_back(vector_integer_t self, std::vector< int >::value_type const & x)"},
-	 { "vector_integer_t_front", _wrap_vector_integer_t_front, METH_O, "vector_integer_t_front(vector_integer_t self) -> std::vector< int >::value_type const &"},
-	 { "vector_integer_t_back", _wrap_vector_integer_t_back, METH_O, "vector_integer_t_back(vector_integer_t self) -> std::vector< int >::value_type const &"},
-	 { "vector_integer_t_assign", _wrap_vector_integer_t_assign, METH_VARARGS, "vector_integer_t_assign(vector_integer_t self, std::vector< int >::size_type n, std::vector< int >::value_type const & x)"},
-	 { "vector_integer_t_resize", _wrap_vector_integer_t_resize, METH_VARARGS, "\n"
-		"vector_integer_t_resize(vector_integer_t self, std::vector< int >::size_type new_size)\n"
-		"vector_integer_t_resize(vector_integer_t self, std::vector< int >::size_type new_size, std::vector< int >::value_type const & x)\n"
+	 { "vector_integer_T_push_back", _wrap_vector_integer_T_push_back, METH_VARARGS, "vector_integer_T_push_back(vector_integer_T self, std::vector< int >::value_type const & x)"},
+	 { "vector_integer_T_front", _wrap_vector_integer_T_front, METH_O, "vector_integer_T_front(vector_integer_T self) -> std::vector< int >::value_type const &"},
+	 { "vector_integer_T_back", _wrap_vector_integer_T_back, METH_O, "vector_integer_T_back(vector_integer_T self) -> std::vector< int >::value_type const &"},
+	 { "vector_integer_T_assign", _wrap_vector_integer_T_assign, METH_VARARGS, "vector_integer_T_assign(vector_integer_T self, std::vector< int >::size_type n, std::vector< int >::value_type const & x)"},
+	 { "vector_integer_T_resize", _wrap_vector_integer_T_resize, METH_VARARGS, "\n"
+		"vector_integer_T_resize(vector_integer_T self, std::vector< int >::size_type new_size)\n"
+		"vector_integer_T_resize(vector_integer_T self, std::vector< int >::size_type new_size, std::vector< int >::value_type const & x)\n"
 		""},
-	 { "vector_integer_t_insert", _wrap_vector_integer_t_insert, METH_VARARGS, "\n"
-		"vector_integer_t_insert(vector_integer_t self, std::vector< int >::iterator pos, std::vector< int >::value_type const & x) -> std::vector< int >::iterator\n"
-		"vector_integer_t_insert(vector_integer_t self, std::vector< int >::iterator pos, std::vector< int >::size_type n, std::vector< int >::value_type const & x)\n"
+	 { "vector_integer_T_insert", _wrap_vector_integer_T_insert, METH_VARARGS, "\n"
+		"vector_integer_T_insert(vector_integer_T self, std::vector< int >::iterator pos, std::vector< int >::value_type const & x) -> std::vector< int >::iterator\n"
+		"vector_integer_T_insert(vector_integer_T self, std::vector< int >::iterator pos, std::vector< int >::size_type n, std::vector< int >::value_type const & x)\n"
 		""},
-	 { "vector_integer_t_reserve", _wrap_vector_integer_t_reserve, METH_VARARGS, "vector_integer_t_reserve(vector_integer_t self, std::vector< int >::size_type n)"},
-	 { "vector_integer_t_capacity", _wrap_vector_integer_t_capacity, METH_O, "vector_integer_t_capacity(vector_integer_t self) -> std::vector< int >::size_type"},
-	 { "delete_vector_integer_t", _wrap_delete_vector_integer_t, METH_O, "delete_vector_integer_t(vector_integer_t self)"},
-	 { "vector_integer_t_swigregister", vector_integer_t_swigregister, METH_O, NULL},
-	 { "vector_integer_t_swiginit", vector_integer_t_swiginit, METH_VARARGS, NULL},
-	 { "vinteger2d_t_iterator", _wrap_vinteger2d_t_iterator, METH_O, "vinteger2d_t_iterator(vinteger2d_t self) -> SwigPyIterator"},
-	 { "vinteger2d_t___nonzero__", _wrap_vinteger2d_t___nonzero__, METH_O, "vinteger2d_t___nonzero__(vinteger2d_t self) -> bool"},
-	 { "vinteger2d_t___bool__", _wrap_vinteger2d_t___bool__, METH_O, "vinteger2d_t___bool__(vinteger2d_t self) -> bool"},
-	 { "vinteger2d_t___len__", _wrap_vinteger2d_t___len__, METH_O, "vinteger2d_t___len__(vinteger2d_t self) -> std::vector< std::vector< int > >::size_type"},
-	 { "vinteger2d_t___getslice__", _wrap_vinteger2d_t___getslice__, METH_VARARGS, "vinteger2d_t___getslice__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j) -> vinteger2d_t"},
-	 { "vinteger2d_t___setslice__", _wrap_vinteger2d_t___setslice__, METH_VARARGS, "\n"
-		"vinteger2d_t___setslice__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j)\n"
-		"vinteger2d_t___setslice__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j, vinteger2d_t v)\n"
+	 { "vector_integer_T_reserve", _wrap_vector_integer_T_reserve, METH_VARARGS, "vector_integer_T_reserve(vector_integer_T self, std::vector< int >::size_type n)"},
+	 { "vector_integer_T_capacity", _wrap_vector_integer_T_capacity, METH_O, "vector_integer_T_capacity(vector_integer_T self) -> std::vector< int >::size_type"},
+	 { "delete_vector_integer_T", _wrap_delete_vector_integer_T, METH_O, "delete_vector_integer_T(vector_integer_T self)"},
+	 { "vector_integer_T_swigregister", vector_integer_T_swigregister, METH_O, NULL},
+	 { "vector_integer_T_swiginit", vector_integer_T_swiginit, METH_VARARGS, NULL},
+	 { "vinteger2d_T_iterator", _wrap_vinteger2d_T_iterator, METH_O, "vinteger2d_T_iterator(vinteger2d_T self) -> SwigPyIterator"},
+	 { "vinteger2d_T___nonzero__", _wrap_vinteger2d_T___nonzero__, METH_O, "vinteger2d_T___nonzero__(vinteger2d_T self) -> bool"},
+	 { "vinteger2d_T___bool__", _wrap_vinteger2d_T___bool__, METH_O, "vinteger2d_T___bool__(vinteger2d_T self) -> bool"},
+	 { "vinteger2d_T___len__", _wrap_vinteger2d_T___len__, METH_O, "vinteger2d_T___len__(vinteger2d_T self) -> std::vector< std::vector< int > >::size_type"},
+	 { "vinteger2d_T___getslice__", _wrap_vinteger2d_T___getslice__, METH_VARARGS, "vinteger2d_T___getslice__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j) -> vinteger2d_T"},
+	 { "vinteger2d_T___setslice__", _wrap_vinteger2d_T___setslice__, METH_VARARGS, "\n"
+		"vinteger2d_T___setslice__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j)\n"
+		"vinteger2d_T___setslice__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j, vinteger2d_T v)\n"
 		""},
-	 { "vinteger2d_t___delslice__", _wrap_vinteger2d_t___delslice__, METH_VARARGS, "vinteger2d_t___delslice__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j)"},
-	 { "vinteger2d_t___delitem__", _wrap_vinteger2d_t___delitem__, METH_VARARGS, "\n"
-		"vinteger2d_t___delitem__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i)\n"
-		"vinteger2d_t___delitem__(vinteger2d_t self, SWIGPY_SLICEOBJECT * slice)\n"
+	 { "vinteger2d_T___delslice__", _wrap_vinteger2d_T___delslice__, METH_VARARGS, "vinteger2d_T___delslice__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j)"},
+	 { "vinteger2d_T___delitem__", _wrap_vinteger2d_T___delitem__, METH_VARARGS, "\n"
+		"vinteger2d_T___delitem__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i)\n"
+		"vinteger2d_T___delitem__(vinteger2d_T self, SWIGPY_SLICEOBJECT * slice)\n"
 		""},
-	 { "vinteger2d_t___getitem__", _wrap_vinteger2d_t___getitem__, METH_VARARGS, "\n"
-		"vinteger2d_t___getitem__(vinteger2d_t self, SWIGPY_SLICEOBJECT * slice) -> vinteger2d_t\n"
-		"vinteger2d_t___getitem__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i) -> vector_integer_t\n"
+	 { "vinteger2d_T___getitem__", _wrap_vinteger2d_T___getitem__, METH_VARARGS, "\n"
+		"vinteger2d_T___getitem__(vinteger2d_T self, SWIGPY_SLICEOBJECT * slice) -> vinteger2d_T\n"
+		"vinteger2d_T___getitem__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i) -> vector_integer_T\n"
 		""},
-	 { "vinteger2d_t___setitem__", _wrap_vinteger2d_t___setitem__, METH_VARARGS, "\n"
-		"vinteger2d_t___setitem__(vinteger2d_t self, SWIGPY_SLICEOBJECT * slice, vinteger2d_t v)\n"
-		"vinteger2d_t___setitem__(vinteger2d_t self, SWIGPY_SLICEOBJECT * slice)\n"
-		"vinteger2d_t___setitem__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i, vector_integer_t x)\n"
+	 { "vinteger2d_T___setitem__", _wrap_vinteger2d_T___setitem__, METH_VARARGS, "\n"
+		"vinteger2d_T___setitem__(vinteger2d_T self, SWIGPY_SLICEOBJECT * slice, vinteger2d_T v)\n"
+		"vinteger2d_T___setitem__(vinteger2d_T self, SWIGPY_SLICEOBJECT * slice)\n"
+		"vinteger2d_T___setitem__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i, vector_integer_T x)\n"
 		""},
-	 { "vinteger2d_t_pop", _wrap_vinteger2d_t_pop, METH_O, "vinteger2d_t_pop(vinteger2d_t self) -> vector_integer_t"},
-	 { "vinteger2d_t_append", _wrap_vinteger2d_t_append, METH_VARARGS, "vinteger2d_t_append(vinteger2d_t self, vector_integer_t x)"},
-	 { "vinteger2d_t_empty", _wrap_vinteger2d_t_empty, METH_O, "vinteger2d_t_empty(vinteger2d_t self) -> bool"},
-	 { "vinteger2d_t_size", _wrap_vinteger2d_t_size, METH_O, "vinteger2d_t_size(vinteger2d_t self) -> std::vector< std::vector< int > >::size_type"},
-	 { "vinteger2d_t_swap", _wrap_vinteger2d_t_swap, METH_VARARGS, "vinteger2d_t_swap(vinteger2d_t self, vinteger2d_t v)"},
-	 { "vinteger2d_t_begin", _wrap_vinteger2d_t_begin, METH_O, "vinteger2d_t_begin(vinteger2d_t self) -> std::vector< std::vector< int > >::iterator"},
-	 { "vinteger2d_t_end", _wrap_vinteger2d_t_end, METH_O, "vinteger2d_t_end(vinteger2d_t self) -> std::vector< std::vector< int > >::iterator"},
-	 { "vinteger2d_t_rbegin", _wrap_vinteger2d_t_rbegin, METH_O, "vinteger2d_t_rbegin(vinteger2d_t self) -> std::vector< std::vector< int > >::reverse_iterator"},
-	 { "vinteger2d_t_rend", _wrap_vinteger2d_t_rend, METH_O, "vinteger2d_t_rend(vinteger2d_t self) -> std::vector< std::vector< int > >::reverse_iterator"},
-	 { "vinteger2d_t_clear", _wrap_vinteger2d_t_clear, METH_O, "vinteger2d_t_clear(vinteger2d_t self)"},
-	 { "vinteger2d_t_get_allocator", _wrap_vinteger2d_t_get_allocator, METH_O, "vinteger2d_t_get_allocator(vinteger2d_t self) -> std::vector< std::vector< int > >::allocator_type"},
-	 { "vinteger2d_t_pop_back", _wrap_vinteger2d_t_pop_back, METH_O, "vinteger2d_t_pop_back(vinteger2d_t self)"},
-	 { "vinteger2d_t_erase", _wrap_vinteger2d_t_erase, METH_VARARGS, "\n"
-		"vinteger2d_t_erase(vinteger2d_t self, std::vector< std::vector< int > >::iterator pos) -> std::vector< std::vector< int > >::iterator\n"
-		"vinteger2d_t_erase(vinteger2d_t self, std::vector< std::vector< int > >::iterator first, std::vector< std::vector< int > >::iterator last) -> std::vector< std::vector< int > >::iterator\n"
+	 { "vinteger2d_T_pop", _wrap_vinteger2d_T_pop, METH_O, "vinteger2d_T_pop(vinteger2d_T self) -> vector_integer_T"},
+	 { "vinteger2d_T_append", _wrap_vinteger2d_T_append, METH_VARARGS, "vinteger2d_T_append(vinteger2d_T self, vector_integer_T x)"},
+	 { "vinteger2d_T_empty", _wrap_vinteger2d_T_empty, METH_O, "vinteger2d_T_empty(vinteger2d_T self) -> bool"},
+	 { "vinteger2d_T_size", _wrap_vinteger2d_T_size, METH_O, "vinteger2d_T_size(vinteger2d_T self) -> std::vector< std::vector< int > >::size_type"},
+	 { "vinteger2d_T_swap", _wrap_vinteger2d_T_swap, METH_VARARGS, "vinteger2d_T_swap(vinteger2d_T self, vinteger2d_T v)"},
+	 { "vinteger2d_T_begin", _wrap_vinteger2d_T_begin, METH_O, "vinteger2d_T_begin(vinteger2d_T self) -> std::vector< std::vector< int > >::iterator"},
+	 { "vinteger2d_T_end", _wrap_vinteger2d_T_end, METH_O, "vinteger2d_T_end(vinteger2d_T self) -> std::vector< std::vector< int > >::iterator"},
+	 { "vinteger2d_T_rbegin", _wrap_vinteger2d_T_rbegin, METH_O, "vinteger2d_T_rbegin(vinteger2d_T self) -> std::vector< std::vector< int > >::reverse_iterator"},
+	 { "vinteger2d_T_rend", _wrap_vinteger2d_T_rend, METH_O, "vinteger2d_T_rend(vinteger2d_T self) -> std::vector< std::vector< int > >::reverse_iterator"},
+	 { "vinteger2d_T_clear", _wrap_vinteger2d_T_clear, METH_O, "vinteger2d_T_clear(vinteger2d_T self)"},
+	 { "vinteger2d_T_get_allocator", _wrap_vinteger2d_T_get_allocator, METH_O, "vinteger2d_T_get_allocator(vinteger2d_T self) -> std::vector< std::vector< int > >::allocator_type"},
+	 { "vinteger2d_T_pop_back", _wrap_vinteger2d_T_pop_back, METH_O, "vinteger2d_T_pop_back(vinteger2d_T self)"},
+	 { "vinteger2d_T_erase", _wrap_vinteger2d_T_erase, METH_VARARGS, "\n"
+		"vinteger2d_T_erase(vinteger2d_T self, std::vector< std::vector< int > >::iterator pos) -> std::vector< std::vector< int > >::iterator\n"
+		"vinteger2d_T_erase(vinteger2d_T self, std::vector< std::vector< int > >::iterator first, std::vector< std::vector< int > >::iterator last) -> std::vector< std::vector< int > >::iterator\n"
 		""},
-	 { "new_vinteger2d_t", _wrap_new_vinteger2d_t, METH_VARARGS, "\n"
-		"vinteger2d_t()\n"
-		"vinteger2d_t(vinteger2d_t other)\n"
-		"vinteger2d_t(std::vector< std::vector< int > >::size_type size)\n"
-		"new_vinteger2d_t(std::vector< std::vector< int > >::size_type size, vector_integer_t value) -> vinteger2d_t\n"
+	 { "new_vinteger2d_T", _wrap_new_vinteger2d_T, METH_VARARGS, "\n"
+		"vinteger2d_T()\n"
+		"vinteger2d_T(vinteger2d_T other)\n"
+		"vinteger2d_T(std::vector< std::vector< int > >::size_type size)\n"
+		"new_vinteger2d_T(std::vector< std::vector< int > >::size_type size, vector_integer_T value) -> vinteger2d_T\n"
 		""},
-	 { "vinteger2d_t_push_back", _wrap_vinteger2d_t_push_back, METH_VARARGS, "vinteger2d_t_push_back(vinteger2d_t self, vector_integer_t x)"},
-	 { "vinteger2d_t_front", _wrap_vinteger2d_t_front, METH_O, "vinteger2d_t_front(vinteger2d_t self) -> vector_integer_t"},
-	 { "vinteger2d_t_back", _wrap_vinteger2d_t_back, METH_O, "vinteger2d_t_back(vinteger2d_t self) -> vector_integer_t"},
-	 { "vinteger2d_t_assign", _wrap_vinteger2d_t_assign, METH_VARARGS, "vinteger2d_t_assign(vinteger2d_t self, std::vector< std::vector< int > >::size_type n, vector_integer_t x)"},
-	 { "vinteger2d_t_resize", _wrap_vinteger2d_t_resize, METH_VARARGS, "\n"
-		"vinteger2d_t_resize(vinteger2d_t self, std::vector< std::vector< int > >::size_type new_size)\n"
-		"vinteger2d_t_resize(vinteger2d_t self, std::vector< std::vector< int > >::size_type new_size, vector_integer_t x)\n"
+	 { "vinteger2d_T_push_back", _wrap_vinteger2d_T_push_back, METH_VARARGS, "vinteger2d_T_push_back(vinteger2d_T self, vector_integer_T x)"},
+	 { "vinteger2d_T_front", _wrap_vinteger2d_T_front, METH_O, "vinteger2d_T_front(vinteger2d_T self) -> vector_integer_T"},
+	 { "vinteger2d_T_back", _wrap_vinteger2d_T_back, METH_O, "vinteger2d_T_back(vinteger2d_T self) -> vector_integer_T"},
+	 { "vinteger2d_T_assign", _wrap_vinteger2d_T_assign, METH_VARARGS, "vinteger2d_T_assign(vinteger2d_T self, std::vector< std::vector< int > >::size_type n, vector_integer_T x)"},
+	 { "vinteger2d_T_resize", _wrap_vinteger2d_T_resize, METH_VARARGS, "\n"
+		"vinteger2d_T_resize(vinteger2d_T self, std::vector< std::vector< int > >::size_type new_size)\n"
+		"vinteger2d_T_resize(vinteger2d_T self, std::vector< std::vector< int > >::size_type new_size, vector_integer_T x)\n"
 		""},
-	 { "vinteger2d_t_insert", _wrap_vinteger2d_t_insert, METH_VARARGS, "\n"
-		"vinteger2d_t_insert(vinteger2d_t self, std::vector< std::vector< int > >::iterator pos, vector_integer_t x) -> std::vector< std::vector< int > >::iterator\n"
-		"vinteger2d_t_insert(vinteger2d_t self, std::vector< std::vector< int > >::iterator pos, std::vector< std::vector< int > >::size_type n, vector_integer_t x)\n"
+	 { "vinteger2d_T_insert", _wrap_vinteger2d_T_insert, METH_VARARGS, "\n"
+		"vinteger2d_T_insert(vinteger2d_T self, std::vector< std::vector< int > >::iterator pos, vector_integer_T x) -> std::vector< std::vector< int > >::iterator\n"
+		"vinteger2d_T_insert(vinteger2d_T self, std::vector< std::vector< int > >::iterator pos, std::vector< std::vector< int > >::size_type n, vector_integer_T x)\n"
 		""},
-	 { "vinteger2d_t_reserve", _wrap_vinteger2d_t_reserve, METH_VARARGS, "vinteger2d_t_reserve(vinteger2d_t self, std::vector< std::vector< int > >::size_type n)"},
-	 { "vinteger2d_t_capacity", _wrap_vinteger2d_t_capacity, METH_O, "vinteger2d_t_capacity(vinteger2d_t self) -> std::vector< std::vector< int > >::size_type"},
-	 { "delete_vinteger2d_t", _wrap_delete_vinteger2d_t, METH_O, "delete_vinteger2d_t(vinteger2d_t self)"},
-	 { "vinteger2d_t_swigregister", vinteger2d_t_swigregister, METH_O, NULL},
-	 { "vinteger2d_t_swiginit", vinteger2d_t_swiginit, METH_VARARGS, NULL},
-	 { "vector_longinteger_t_iterator", _wrap_vector_longinteger_t_iterator, METH_O, "vector_longinteger_t_iterator(vector_longinteger_t self) -> SwigPyIterator"},
-	 { "vector_longinteger_t___nonzero__", _wrap_vector_longinteger_t___nonzero__, METH_O, "vector_longinteger_t___nonzero__(vector_longinteger_t self) -> bool"},
-	 { "vector_longinteger_t___bool__", _wrap_vector_longinteger_t___bool__, METH_O, "vector_longinteger_t___bool__(vector_longinteger_t self) -> bool"},
-	 { "vector_longinteger_t___len__", _wrap_vector_longinteger_t___len__, METH_O, "vector_longinteger_t___len__(vector_longinteger_t self) -> std::vector< unsigned long >::size_type"},
-	 { "vector_longinteger_t___getslice__", _wrap_vector_longinteger_t___getslice__, METH_VARARGS, "vector_longinteger_t___getslice__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j) -> vector_longinteger_t"},
-	 { "vector_longinteger_t___setslice__", _wrap_vector_longinteger_t___setslice__, METH_VARARGS, "\n"
-		"vector_longinteger_t___setslice__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j)\n"
-		"vector_longinteger_t___setslice__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j, vector_longinteger_t v)\n"
+	 { "vinteger2d_T_reserve", _wrap_vinteger2d_T_reserve, METH_VARARGS, "vinteger2d_T_reserve(vinteger2d_T self, std::vector< std::vector< int > >::size_type n)"},
+	 { "vinteger2d_T_capacity", _wrap_vinteger2d_T_capacity, METH_O, "vinteger2d_T_capacity(vinteger2d_T self) -> std::vector< std::vector< int > >::size_type"},
+	 { "delete_vinteger2d_T", _wrap_delete_vinteger2d_T, METH_O, "delete_vinteger2d_T(vinteger2d_T self)"},
+	 { "vinteger2d_T_swigregister", vinteger2d_T_swigregister, METH_O, NULL},
+	 { "vinteger2d_T_swiginit", vinteger2d_T_swiginit, METH_VARARGS, NULL},
+	 { "vector_longinteger_T_iterator", _wrap_vector_longinteger_T_iterator, METH_O, "vector_longinteger_T_iterator(vector_longinteger_T self) -> SwigPyIterator"},
+	 { "vector_longinteger_T___nonzero__", _wrap_vector_longinteger_T___nonzero__, METH_O, "vector_longinteger_T___nonzero__(vector_longinteger_T self) -> bool"},
+	 { "vector_longinteger_T___bool__", _wrap_vector_longinteger_T___bool__, METH_O, "vector_longinteger_T___bool__(vector_longinteger_T self) -> bool"},
+	 { "vector_longinteger_T___len__", _wrap_vector_longinteger_T___len__, METH_O, "vector_longinteger_T___len__(vector_longinteger_T self) -> std::vector< unsigned long >::size_type"},
+	 { "vector_longinteger_T___getslice__", _wrap_vector_longinteger_T___getslice__, METH_VARARGS, "vector_longinteger_T___getslice__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j) -> vector_longinteger_T"},
+	 { "vector_longinteger_T___setslice__", _wrap_vector_longinteger_T___setslice__, METH_VARARGS, "\n"
+		"vector_longinteger_T___setslice__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j)\n"
+		"vector_longinteger_T___setslice__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j, vector_longinteger_T v)\n"
 		""},
-	 { "vector_longinteger_t___delslice__", _wrap_vector_longinteger_t___delslice__, METH_VARARGS, "vector_longinteger_t___delslice__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j)"},
-	 { "vector_longinteger_t___delitem__", _wrap_vector_longinteger_t___delitem__, METH_VARARGS, "\n"
-		"vector_longinteger_t___delitem__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i)\n"
-		"vector_longinteger_t___delitem__(vector_longinteger_t self, SWIGPY_SLICEOBJECT * slice)\n"
+	 { "vector_longinteger_T___delslice__", _wrap_vector_longinteger_T___delslice__, METH_VARARGS, "vector_longinteger_T___delslice__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j)"},
+	 { "vector_longinteger_T___delitem__", _wrap_vector_longinteger_T___delitem__, METH_VARARGS, "\n"
+		"vector_longinteger_T___delitem__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i)\n"
+		"vector_longinteger_T___delitem__(vector_longinteger_T self, SWIGPY_SLICEOBJECT * slice)\n"
 		""},
-	 { "vector_longinteger_t___getitem__", _wrap_vector_longinteger_t___getitem__, METH_VARARGS, "\n"
-		"vector_longinteger_t___getitem__(vector_longinteger_t self, SWIGPY_SLICEOBJECT * slice) -> vector_longinteger_t\n"
-		"vector_longinteger_t___getitem__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i) -> std::vector< unsigned long >::value_type const &\n"
+	 { "vector_longinteger_T___getitem__", _wrap_vector_longinteger_T___getitem__, METH_VARARGS, "\n"
+		"vector_longinteger_T___getitem__(vector_longinteger_T self, SWIGPY_SLICEOBJECT * slice) -> vector_longinteger_T\n"
+		"vector_longinteger_T___getitem__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i) -> std::vector< unsigned long >::value_type const &\n"
 		""},
-	 { "vector_longinteger_t___setitem__", _wrap_vector_longinteger_t___setitem__, METH_VARARGS, "\n"
-		"vector_longinteger_t___setitem__(vector_longinteger_t self, SWIGPY_SLICEOBJECT * slice, vector_longinteger_t v)\n"
-		"vector_longinteger_t___setitem__(vector_longinteger_t self, SWIGPY_SLICEOBJECT * slice)\n"
-		"vector_longinteger_t___setitem__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::value_type const & x)\n"
+	 { "vector_longinteger_T___setitem__", _wrap_vector_longinteger_T___setitem__, METH_VARARGS, "\n"
+		"vector_longinteger_T___setitem__(vector_longinteger_T self, SWIGPY_SLICEOBJECT * slice, vector_longinteger_T v)\n"
+		"vector_longinteger_T___setitem__(vector_longinteger_T self, SWIGPY_SLICEOBJECT * slice)\n"
+		"vector_longinteger_T___setitem__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::value_type const & x)\n"
 		""},
-	 { "vector_longinteger_t_pop", _wrap_vector_longinteger_t_pop, METH_O, "vector_longinteger_t_pop(vector_longinteger_t self) -> std::vector< unsigned long >::value_type"},
-	 { "vector_longinteger_t_append", _wrap_vector_longinteger_t_append, METH_VARARGS, "vector_longinteger_t_append(vector_longinteger_t self, std::vector< unsigned long >::value_type const & x)"},
-	 { "vector_longinteger_t_empty", _wrap_vector_longinteger_t_empty, METH_O, "vector_longinteger_t_empty(vector_longinteger_t self) -> bool"},
-	 { "vector_longinteger_t_size", _wrap_vector_longinteger_t_size, METH_O, "vector_longinteger_t_size(vector_longinteger_t self) -> std::vector< unsigned long >::size_type"},
-	 { "vector_longinteger_t_swap", _wrap_vector_longinteger_t_swap, METH_VARARGS, "vector_longinteger_t_swap(vector_longinteger_t self, vector_longinteger_t v)"},
-	 { "vector_longinteger_t_begin", _wrap_vector_longinteger_t_begin, METH_O, "vector_longinteger_t_begin(vector_longinteger_t self) -> std::vector< unsigned long >::iterator"},
-	 { "vector_longinteger_t_end", _wrap_vector_longinteger_t_end, METH_O, "vector_longinteger_t_end(vector_longinteger_t self) -> std::vector< unsigned long >::iterator"},
-	 { "vector_longinteger_t_rbegin", _wrap_vector_longinteger_t_rbegin, METH_O, "vector_longinteger_t_rbegin(vector_longinteger_t self) -> std::vector< unsigned long >::reverse_iterator"},
-	 { "vector_longinteger_t_rend", _wrap_vector_longinteger_t_rend, METH_O, "vector_longinteger_t_rend(vector_longinteger_t self) -> std::vector< unsigned long >::reverse_iterator"},
-	 { "vector_longinteger_t_clear", _wrap_vector_longinteger_t_clear, METH_O, "vector_longinteger_t_clear(vector_longinteger_t self)"},
-	 { "vector_longinteger_t_get_allocator", _wrap_vector_longinteger_t_get_allocator, METH_O, "vector_longinteger_t_get_allocator(vector_longinteger_t self) -> std::vector< unsigned long >::allocator_type"},
-	 { "vector_longinteger_t_pop_back", _wrap_vector_longinteger_t_pop_back, METH_O, "vector_longinteger_t_pop_back(vector_longinteger_t self)"},
-	 { "vector_longinteger_t_erase", _wrap_vector_longinteger_t_erase, METH_VARARGS, "\n"
-		"vector_longinteger_t_erase(vector_longinteger_t self, std::vector< unsigned long >::iterator pos) -> std::vector< unsigned long >::iterator\n"
-		"vector_longinteger_t_erase(vector_longinteger_t self, std::vector< unsigned long >::iterator first, std::vector< unsigned long >::iterator last) -> std::vector< unsigned long >::iterator\n"
+	 { "vector_longinteger_T_pop", _wrap_vector_longinteger_T_pop, METH_O, "vector_longinteger_T_pop(vector_longinteger_T self) -> std::vector< unsigned long >::value_type"},
+	 { "vector_longinteger_T_append", _wrap_vector_longinteger_T_append, METH_VARARGS, "vector_longinteger_T_append(vector_longinteger_T self, std::vector< unsigned long >::value_type const & x)"},
+	 { "vector_longinteger_T_empty", _wrap_vector_longinteger_T_empty, METH_O, "vector_longinteger_T_empty(vector_longinteger_T self) -> bool"},
+	 { "vector_longinteger_T_size", _wrap_vector_longinteger_T_size, METH_O, "vector_longinteger_T_size(vector_longinteger_T self) -> std::vector< unsigned long >::size_type"},
+	 { "vector_longinteger_T_swap", _wrap_vector_longinteger_T_swap, METH_VARARGS, "vector_longinteger_T_swap(vector_longinteger_T self, vector_longinteger_T v)"},
+	 { "vector_longinteger_T_begin", _wrap_vector_longinteger_T_begin, METH_O, "vector_longinteger_T_begin(vector_longinteger_T self) -> std::vector< unsigned long >::iterator"},
+	 { "vector_longinteger_T_end", _wrap_vector_longinteger_T_end, METH_O, "vector_longinteger_T_end(vector_longinteger_T self) -> std::vector< unsigned long >::iterator"},
+	 { "vector_longinteger_T_rbegin", _wrap_vector_longinteger_T_rbegin, METH_O, "vector_longinteger_T_rbegin(vector_longinteger_T self) -> std::vector< unsigned long >::reverse_iterator"},
+	 { "vector_longinteger_T_rend", _wrap_vector_longinteger_T_rend, METH_O, "vector_longinteger_T_rend(vector_longinteger_T self) -> std::vector< unsigned long >::reverse_iterator"},
+	 { "vector_longinteger_T_clear", _wrap_vector_longinteger_T_clear, METH_O, "vector_longinteger_T_clear(vector_longinteger_T self)"},
+	 { "vector_longinteger_T_get_allocator", _wrap_vector_longinteger_T_get_allocator, METH_O, "vector_longinteger_T_get_allocator(vector_longinteger_T self) -> std::vector< unsigned long >::allocator_type"},
+	 { "vector_longinteger_T_pop_back", _wrap_vector_longinteger_T_pop_back, METH_O, "vector_longinteger_T_pop_back(vector_longinteger_T self)"},
+	 { "vector_longinteger_T_erase", _wrap_vector_longinteger_T_erase, METH_VARARGS, "\n"
+		"vector_longinteger_T_erase(vector_longinteger_T self, std::vector< unsigned long >::iterator pos) -> std::vector< unsigned long >::iterator\n"
+		"vector_longinteger_T_erase(vector_longinteger_T self, std::vector< unsigned long >::iterator first, std::vector< unsigned long >::iterator last) -> std::vector< unsigned long >::iterator\n"
 		""},
-	 { "new_vector_longinteger_t", _wrap_new_vector_longinteger_t, METH_VARARGS, "\n"
-		"vector_longinteger_t()\n"
-		"vector_longinteger_t(vector_longinteger_t other)\n"
-		"vector_longinteger_t(std::vector< unsigned long >::size_type size)\n"
-		"new_vector_longinteger_t(std::vector< unsigned long >::size_type size, std::vector< unsigned long >::value_type const & value) -> vector_longinteger_t\n"
+	 { "new_vector_longinteger_T", _wrap_new_vector_longinteger_T, METH_VARARGS, "\n"
+		"vector_longinteger_T()\n"
+		"vector_longinteger_T(vector_longinteger_T other)\n"
+		"vector_longinteger_T(std::vector< unsigned long >::size_type size)\n"
+		"new_vector_longinteger_T(std::vector< unsigned long >::size_type size, std::vector< unsigned long >::value_type const & value) -> vector_longinteger_T\n"
 		""},
-	 { "vector_longinteger_t_push_back", _wrap_vector_longinteger_t_push_back, METH_VARARGS, "vector_longinteger_t_push_back(vector_longinteger_t self, std::vector< unsigned long >::value_type const & x)"},
-	 { "vector_longinteger_t_front", _wrap_vector_longinteger_t_front, METH_O, "vector_longinteger_t_front(vector_longinteger_t self) -> std::vector< unsigned long >::value_type const &"},
-	 { "vector_longinteger_t_back", _wrap_vector_longinteger_t_back, METH_O, "vector_longinteger_t_back(vector_longinteger_t self) -> std::vector< unsigned long >::value_type const &"},
-	 { "vector_longinteger_t_assign", _wrap_vector_longinteger_t_assign, METH_VARARGS, "vector_longinteger_t_assign(vector_longinteger_t self, std::vector< unsigned long >::size_type n, std::vector< unsigned long >::value_type const & x)"},
-	 { "vector_longinteger_t_resize", _wrap_vector_longinteger_t_resize, METH_VARARGS, "\n"
-		"vector_longinteger_t_resize(vector_longinteger_t self, std::vector< unsigned long >::size_type new_size)\n"
-		"vector_longinteger_t_resize(vector_longinteger_t self, std::vector< unsigned long >::size_type new_size, std::vector< unsigned long >::value_type const & x)\n"
+	 { "vector_longinteger_T_push_back", _wrap_vector_longinteger_T_push_back, METH_VARARGS, "vector_longinteger_T_push_back(vector_longinteger_T self, std::vector< unsigned long >::value_type const & x)"},
+	 { "vector_longinteger_T_front", _wrap_vector_longinteger_T_front, METH_O, "vector_longinteger_T_front(vector_longinteger_T self) -> std::vector< unsigned long >::value_type const &"},
+	 { "vector_longinteger_T_back", _wrap_vector_longinteger_T_back, METH_O, "vector_longinteger_T_back(vector_longinteger_T self) -> std::vector< unsigned long >::value_type const &"},
+	 { "vector_longinteger_T_assign", _wrap_vector_longinteger_T_assign, METH_VARARGS, "vector_longinteger_T_assign(vector_longinteger_T self, std::vector< unsigned long >::size_type n, std::vector< unsigned long >::value_type const & x)"},
+	 { "vector_longinteger_T_resize", _wrap_vector_longinteger_T_resize, METH_VARARGS, "\n"
+		"vector_longinteger_T_resize(vector_longinteger_T self, std::vector< unsigned long >::size_type new_size)\n"
+		"vector_longinteger_T_resize(vector_longinteger_T self, std::vector< unsigned long >::size_type new_size, std::vector< unsigned long >::value_type const & x)\n"
 		""},
-	 { "vector_longinteger_t_insert", _wrap_vector_longinteger_t_insert, METH_VARARGS, "\n"
-		"vector_longinteger_t_insert(vector_longinteger_t self, std::vector< unsigned long >::iterator pos, std::vector< unsigned long >::value_type const & x) -> std::vector< unsigned long >::iterator\n"
-		"vector_longinteger_t_insert(vector_longinteger_t self, std::vector< unsigned long >::iterator pos, std::vector< unsigned long >::size_type n, std::vector< unsigned long >::value_type const & x)\n"
+	 { "vector_longinteger_T_insert", _wrap_vector_longinteger_T_insert, METH_VARARGS, "\n"
+		"vector_longinteger_T_insert(vector_longinteger_T self, std::vector< unsigned long >::iterator pos, std::vector< unsigned long >::value_type const & x) -> std::vector< unsigned long >::iterator\n"
+		"vector_longinteger_T_insert(vector_longinteger_T self, std::vector< unsigned long >::iterator pos, std::vector< unsigned long >::size_type n, std::vector< unsigned long >::value_type const & x)\n"
 		""},
-	 { "vector_longinteger_t_reserve", _wrap_vector_longinteger_t_reserve, METH_VARARGS, "vector_longinteger_t_reserve(vector_longinteger_t self, std::vector< unsigned long >::size_type n)"},
-	 { "vector_longinteger_t_capacity", _wrap_vector_longinteger_t_capacity, METH_O, "vector_longinteger_t_capacity(vector_longinteger_t self) -> std::vector< unsigned long >::size_type"},
-	 { "delete_vector_longinteger_t", _wrap_delete_vector_longinteger_t, METH_O, "delete_vector_longinteger_t(vector_longinteger_t self)"},
-	 { "vector_longinteger_t_swigregister", vector_longinteger_t_swigregister, METH_O, NULL},
-	 { "vector_longinteger_t_swiginit", vector_longinteger_t_swiginit, METH_VARARGS, NULL},
-	 { "vector_complex_t_iterator", _wrap_vector_complex_t_iterator, METH_O, "vector_complex_t_iterator(vector_complex_t self) -> SwigPyIterator"},
-	 { "vector_complex_t___nonzero__", _wrap_vector_complex_t___nonzero__, METH_O, "vector_complex_t___nonzero__(vector_complex_t self) -> bool"},
-	 { "vector_complex_t___bool__", _wrap_vector_complex_t___bool__, METH_O, "vector_complex_t___bool__(vector_complex_t self) -> bool"},
-	 { "vector_complex_t___len__", _wrap_vector_complex_t___len__, METH_O, "vector_complex_t___len__(vector_complex_t self) -> std::vector< std::complex< double > >::size_type"},
-	 { "vector_complex_t___getslice__", _wrap_vector_complex_t___getslice__, METH_VARARGS, "vector_complex_t___getslice__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j) -> vector_complex_t"},
-	 { "vector_complex_t___setslice__", _wrap_vector_complex_t___setslice__, METH_VARARGS, "\n"
-		"vector_complex_t___setslice__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j)\n"
-		"vector_complex_t___setslice__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j, vector_complex_t v)\n"
+	 { "vector_longinteger_T_reserve", _wrap_vector_longinteger_T_reserve, METH_VARARGS, "vector_longinteger_T_reserve(vector_longinteger_T self, std::vector< unsigned long >::size_type n)"},
+	 { "vector_longinteger_T_capacity", _wrap_vector_longinteger_T_capacity, METH_O, "vector_longinteger_T_capacity(vector_longinteger_T self) -> std::vector< unsigned long >::size_type"},
+	 { "delete_vector_longinteger_T", _wrap_delete_vector_longinteger_T, METH_O, "delete_vector_longinteger_T(vector_longinteger_T self)"},
+	 { "vector_longinteger_T_swigregister", vector_longinteger_T_swigregister, METH_O, NULL},
+	 { "vector_longinteger_T_swiginit", vector_longinteger_T_swiginit, METH_VARARGS, NULL},
+	 { "vector_complex_T_iterator", _wrap_vector_complex_T_iterator, METH_O, "vector_complex_T_iterator(vector_complex_T self) -> SwigPyIterator"},
+	 { "vector_complex_T___nonzero__", _wrap_vector_complex_T___nonzero__, METH_O, "vector_complex_T___nonzero__(vector_complex_T self) -> bool"},
+	 { "vector_complex_T___bool__", _wrap_vector_complex_T___bool__, METH_O, "vector_complex_T___bool__(vector_complex_T self) -> bool"},
+	 { "vector_complex_T___len__", _wrap_vector_complex_T___len__, METH_O, "vector_complex_T___len__(vector_complex_T self) -> std::vector< std::complex< double > >::size_type"},
+	 { "vector_complex_T___getslice__", _wrap_vector_complex_T___getslice__, METH_VARARGS, "vector_complex_T___getslice__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j) -> vector_complex_T"},
+	 { "vector_complex_T___setslice__", _wrap_vector_complex_T___setslice__, METH_VARARGS, "\n"
+		"vector_complex_T___setslice__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j)\n"
+		"vector_complex_T___setslice__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j, vector_complex_T v)\n"
 		""},
-	 { "vector_complex_t___delslice__", _wrap_vector_complex_t___delslice__, METH_VARARGS, "vector_complex_t___delslice__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j)"},
-	 { "vector_complex_t___delitem__", _wrap_vector_complex_t___delitem__, METH_VARARGS, "\n"
-		"vector_complex_t___delitem__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i)\n"
-		"vector_complex_t___delitem__(vector_complex_t self, SWIGPY_SLICEOBJECT * slice)\n"
+	 { "vector_complex_T___delslice__", _wrap_vector_complex_T___delslice__, METH_VARARGS, "vector_complex_T___delslice__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j)"},
+	 { "vector_complex_T___delitem__", _wrap_vector_complex_T___delitem__, METH_VARARGS, "\n"
+		"vector_complex_T___delitem__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i)\n"
+		"vector_complex_T___delitem__(vector_complex_T self, SWIGPY_SLICEOBJECT * slice)\n"
 		""},
-	 { "vector_complex_t___getitem__", _wrap_vector_complex_t___getitem__, METH_VARARGS, "\n"
-		"vector_complex_t___getitem__(vector_complex_t self, SWIGPY_SLICEOBJECT * slice) -> vector_complex_t\n"
-		"vector_complex_t___getitem__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i) -> std::vector< std::complex< double > >::value_type const &\n"
+	 { "vector_complex_T___getitem__", _wrap_vector_complex_T___getitem__, METH_VARARGS, "\n"
+		"vector_complex_T___getitem__(vector_complex_T self, SWIGPY_SLICEOBJECT * slice) -> vector_complex_T\n"
+		"vector_complex_T___getitem__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i) -> std::vector< std::complex< double > >::value_type const &\n"
 		""},
-	 { "vector_complex_t___setitem__", _wrap_vector_complex_t___setitem__, METH_VARARGS, "\n"
-		"vector_complex_t___setitem__(vector_complex_t self, SWIGPY_SLICEOBJECT * slice, vector_complex_t v)\n"
-		"vector_complex_t___setitem__(vector_complex_t self, SWIGPY_SLICEOBJECT * slice)\n"
-		"vector_complex_t___setitem__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::value_type const & x)\n"
+	 { "vector_complex_T___setitem__", _wrap_vector_complex_T___setitem__, METH_VARARGS, "\n"
+		"vector_complex_T___setitem__(vector_complex_T self, SWIGPY_SLICEOBJECT * slice, vector_complex_T v)\n"
+		"vector_complex_T___setitem__(vector_complex_T self, SWIGPY_SLICEOBJECT * slice)\n"
+		"vector_complex_T___setitem__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::value_type const & x)\n"
 		""},
-	 { "vector_complex_t_pop", _wrap_vector_complex_t_pop, METH_O, "vector_complex_t_pop(vector_complex_t self) -> std::vector< std::complex< double > >::value_type"},
-	 { "vector_complex_t_append", _wrap_vector_complex_t_append, METH_VARARGS, "vector_complex_t_append(vector_complex_t self, std::vector< std::complex< double > >::value_type const & x)"},
-	 { "vector_complex_t_empty", _wrap_vector_complex_t_empty, METH_O, "vector_complex_t_empty(vector_complex_t self) -> bool"},
-	 { "vector_complex_t_size", _wrap_vector_complex_t_size, METH_O, "vector_complex_t_size(vector_complex_t self) -> std::vector< std::complex< double > >::size_type"},
-	 { "vector_complex_t_swap", _wrap_vector_complex_t_swap, METH_VARARGS, "vector_complex_t_swap(vector_complex_t self, vector_complex_t v)"},
-	 { "vector_complex_t_begin", _wrap_vector_complex_t_begin, METH_O, "vector_complex_t_begin(vector_complex_t self) -> std::vector< std::complex< double > >::iterator"},
-	 { "vector_complex_t_end", _wrap_vector_complex_t_end, METH_O, "vector_complex_t_end(vector_complex_t self) -> std::vector< std::complex< double > >::iterator"},
-	 { "vector_complex_t_rbegin", _wrap_vector_complex_t_rbegin, METH_O, "vector_complex_t_rbegin(vector_complex_t self) -> std::vector< std::complex< double > >::reverse_iterator"},
-	 { "vector_complex_t_rend", _wrap_vector_complex_t_rend, METH_O, "vector_complex_t_rend(vector_complex_t self) -> std::vector< std::complex< double > >::reverse_iterator"},
-	 { "vector_complex_t_clear", _wrap_vector_complex_t_clear, METH_O, "vector_complex_t_clear(vector_complex_t self)"},
-	 { "vector_complex_t_get_allocator", _wrap_vector_complex_t_get_allocator, METH_O, "vector_complex_t_get_allocator(vector_complex_t self) -> std::vector< std::complex< double > >::allocator_type"},
-	 { "vector_complex_t_pop_back", _wrap_vector_complex_t_pop_back, METH_O, "vector_complex_t_pop_back(vector_complex_t self)"},
-	 { "vector_complex_t_erase", _wrap_vector_complex_t_erase, METH_VARARGS, "\n"
-		"vector_complex_t_erase(vector_complex_t self, std::vector< std::complex< double > >::iterator pos) -> std::vector< std::complex< double > >::iterator\n"
-		"vector_complex_t_erase(vector_complex_t self, std::vector< std::complex< double > >::iterator first, std::vector< std::complex< double > >::iterator last) -> std::vector< std::complex< double > >::iterator\n"
+	 { "vector_complex_T_pop", _wrap_vector_complex_T_pop, METH_O, "vector_complex_T_pop(vector_complex_T self) -> std::vector< std::complex< double > >::value_type"},
+	 { "vector_complex_T_append", _wrap_vector_complex_T_append, METH_VARARGS, "vector_complex_T_append(vector_complex_T self, std::vector< std::complex< double > >::value_type const & x)"},
+	 { "vector_complex_T_empty", _wrap_vector_complex_T_empty, METH_O, "vector_complex_T_empty(vector_complex_T self) -> bool"},
+	 { "vector_complex_T_size", _wrap_vector_complex_T_size, METH_O, "vector_complex_T_size(vector_complex_T self) -> std::vector< std::complex< double > >::size_type"},
+	 { "vector_complex_T_swap", _wrap_vector_complex_T_swap, METH_VARARGS, "vector_complex_T_swap(vector_complex_T self, vector_complex_T v)"},
+	 { "vector_complex_T_begin", _wrap_vector_complex_T_begin, METH_O, "vector_complex_T_begin(vector_complex_T self) -> std::vector< std::complex< double > >::iterator"},
+	 { "vector_complex_T_end", _wrap_vector_complex_T_end, METH_O, "vector_complex_T_end(vector_complex_T self) -> std::vector< std::complex< double > >::iterator"},
+	 { "vector_complex_T_rbegin", _wrap_vector_complex_T_rbegin, METH_O, "vector_complex_T_rbegin(vector_complex_T self) -> std::vector< std::complex< double > >::reverse_iterator"},
+	 { "vector_complex_T_rend", _wrap_vector_complex_T_rend, METH_O, "vector_complex_T_rend(vector_complex_T self) -> std::vector< std::complex< double > >::reverse_iterator"},
+	 { "vector_complex_T_clear", _wrap_vector_complex_T_clear, METH_O, "vector_complex_T_clear(vector_complex_T self)"},
+	 { "vector_complex_T_get_allocator", _wrap_vector_complex_T_get_allocator, METH_O, "vector_complex_T_get_allocator(vector_complex_T self) -> std::vector< std::complex< double > >::allocator_type"},
+	 { "vector_complex_T_pop_back", _wrap_vector_complex_T_pop_back, METH_O, "vector_complex_T_pop_back(vector_complex_T self)"},
+	 { "vector_complex_T_erase", _wrap_vector_complex_T_erase, METH_VARARGS, "\n"
+		"vector_complex_T_erase(vector_complex_T self, std::vector< std::complex< double > >::iterator pos) -> std::vector< std::complex< double > >::iterator\n"
+		"vector_complex_T_erase(vector_complex_T self, std::vector< std::complex< double > >::iterator first, std::vector< std::complex< double > >::iterator last) -> std::vector< std::complex< double > >::iterator\n"
 		""},
-	 { "new_vector_complex_t", _wrap_new_vector_complex_t, METH_VARARGS, "\n"
-		"vector_complex_t()\n"
-		"vector_complex_t(vector_complex_t other)\n"
-		"vector_complex_t(std::vector< std::complex< double > >::size_type size)\n"
-		"new_vector_complex_t(std::vector< std::complex< double > >::size_type size, std::vector< std::complex< double > >::value_type const & value) -> vector_complex_t\n"
+	 { "new_vector_complex_T", _wrap_new_vector_complex_T, METH_VARARGS, "\n"
+		"vector_complex_T()\n"
+		"vector_complex_T(vector_complex_T other)\n"
+		"vector_complex_T(std::vector< std::complex< double > >::size_type size)\n"
+		"new_vector_complex_T(std::vector< std::complex< double > >::size_type size, std::vector< std::complex< double > >::value_type const & value) -> vector_complex_T\n"
 		""},
-	 { "vector_complex_t_push_back", _wrap_vector_complex_t_push_back, METH_VARARGS, "vector_complex_t_push_back(vector_complex_t self, std::vector< std::complex< double > >::value_type const & x)"},
-	 { "vector_complex_t_front", _wrap_vector_complex_t_front, METH_O, "vector_complex_t_front(vector_complex_t self) -> std::vector< std::complex< double > >::value_type const &"},
-	 { "vector_complex_t_back", _wrap_vector_complex_t_back, METH_O, "vector_complex_t_back(vector_complex_t self) -> std::vector< std::complex< double > >::value_type const &"},
-	 { "vector_complex_t_assign", _wrap_vector_complex_t_assign, METH_VARARGS, "vector_complex_t_assign(vector_complex_t self, std::vector< std::complex< double > >::size_type n, std::vector< std::complex< double > >::value_type const & x)"},
-	 { "vector_complex_t_resize", _wrap_vector_complex_t_resize, METH_VARARGS, "\n"
-		"vector_complex_t_resize(vector_complex_t self, std::vector< std::complex< double > >::size_type new_size)\n"
-		"vector_complex_t_resize(vector_complex_t self, std::vector< std::complex< double > >::size_type new_size, std::vector< std::complex< double > >::value_type const & x)\n"
+	 { "vector_complex_T_push_back", _wrap_vector_complex_T_push_back, METH_VARARGS, "vector_complex_T_push_back(vector_complex_T self, std::vector< std::complex< double > >::value_type const & x)"},
+	 { "vector_complex_T_front", _wrap_vector_complex_T_front, METH_O, "vector_complex_T_front(vector_complex_T self) -> std::vector< std::complex< double > >::value_type const &"},
+	 { "vector_complex_T_back", _wrap_vector_complex_T_back, METH_O, "vector_complex_T_back(vector_complex_T self) -> std::vector< std::complex< double > >::value_type const &"},
+	 { "vector_complex_T_assign", _wrap_vector_complex_T_assign, METH_VARARGS, "vector_complex_T_assign(vector_complex_T self, std::vector< std::complex< double > >::size_type n, std::vector< std::complex< double > >::value_type const & x)"},
+	 { "vector_complex_T_resize", _wrap_vector_complex_T_resize, METH_VARARGS, "\n"
+		"vector_complex_T_resize(vector_complex_T self, std::vector< std::complex< double > >::size_type new_size)\n"
+		"vector_complex_T_resize(vector_complex_T self, std::vector< std::complex< double > >::size_type new_size, std::vector< std::complex< double > >::value_type const & x)\n"
 		""},
-	 { "vector_complex_t_insert", _wrap_vector_complex_t_insert, METH_VARARGS, "\n"
-		"vector_complex_t_insert(vector_complex_t self, std::vector< std::complex< double > >::iterator pos, std::vector< std::complex< double > >::value_type const & x) -> std::vector< std::complex< double > >::iterator\n"
-		"vector_complex_t_insert(vector_complex_t self, std::vector< std::complex< double > >::iterator pos, std::vector< std::complex< double > >::size_type n, std::vector< std::complex< double > >::value_type const & x)\n"
+	 { "vector_complex_T_insert", _wrap_vector_complex_T_insert, METH_VARARGS, "\n"
+		"vector_complex_T_insert(vector_complex_T self, std::vector< std::complex< double > >::iterator pos, std::vector< std::complex< double > >::value_type const & x) -> std::vector< std::complex< double > >::iterator\n"
+		"vector_complex_T_insert(vector_complex_T self, std::vector< std::complex< double > >::iterator pos, std::vector< std::complex< double > >::size_type n, std::vector< std::complex< double > >::value_type const & x)\n"
 		""},
-	 { "vector_complex_t_reserve", _wrap_vector_complex_t_reserve, METH_VARARGS, "vector_complex_t_reserve(vector_complex_t self, std::vector< std::complex< double > >::size_type n)"},
-	 { "vector_complex_t_capacity", _wrap_vector_complex_t_capacity, METH_O, "vector_complex_t_capacity(vector_complex_t self) -> std::vector< std::complex< double > >::size_type"},
-	 { "delete_vector_complex_t", _wrap_delete_vector_complex_t, METH_O, "delete_vector_complex_t(vector_complex_t self)"},
-	 { "vector_complex_t_swigregister", vector_complex_t_swigregister, METH_O, NULL},
-	 { "vector_complex_t_swiginit", vector_complex_t_swiginit, METH_VARARGS, NULL},
-	 { "vector_string_t_iterator", _wrap_vector_string_t_iterator, METH_O, "vector_string_t_iterator(vector_string_t self) -> SwigPyIterator"},
-	 { "vector_string_t___nonzero__", _wrap_vector_string_t___nonzero__, METH_O, "vector_string_t___nonzero__(vector_string_t self) -> bool"},
-	 { "vector_string_t___bool__", _wrap_vector_string_t___bool__, METH_O, "vector_string_t___bool__(vector_string_t self) -> bool"},
-	 { "vector_string_t___len__", _wrap_vector_string_t___len__, METH_O, "vector_string_t___len__(vector_string_t self) -> std::vector< std::string >::size_type"},
-	 { "vector_string_t___getslice__", _wrap_vector_string_t___getslice__, METH_VARARGS, "vector_string_t___getslice__(vector_string_t self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j) -> vector_string_t"},
-	 { "vector_string_t___setslice__", _wrap_vector_string_t___setslice__, METH_VARARGS, "\n"
-		"vector_string_t___setslice__(vector_string_t self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j)\n"
-		"vector_string_t___setslice__(vector_string_t self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j, vector_string_t v)\n"
+	 { "vector_complex_T_reserve", _wrap_vector_complex_T_reserve, METH_VARARGS, "vector_complex_T_reserve(vector_complex_T self, std::vector< std::complex< double > >::size_type n)"},
+	 { "vector_complex_T_capacity", _wrap_vector_complex_T_capacity, METH_O, "vector_complex_T_capacity(vector_complex_T self) -> std::vector< std::complex< double > >::size_type"},
+	 { "delete_vector_complex_T", _wrap_delete_vector_complex_T, METH_O, "delete_vector_complex_T(vector_complex_T self)"},
+	 { "vector_complex_T_swigregister", vector_complex_T_swigregister, METH_O, NULL},
+	 { "vector_complex_T_swiginit", vector_complex_T_swiginit, METH_VARARGS, NULL},
+	 { "vector_string_T_iterator", _wrap_vector_string_T_iterator, METH_O, "vector_string_T_iterator(vector_string_T self) -> SwigPyIterator"},
+	 { "vector_string_T___nonzero__", _wrap_vector_string_T___nonzero__, METH_O, "vector_string_T___nonzero__(vector_string_T self) -> bool"},
+	 { "vector_string_T___bool__", _wrap_vector_string_T___bool__, METH_O, "vector_string_T___bool__(vector_string_T self) -> bool"},
+	 { "vector_string_T___len__", _wrap_vector_string_T___len__, METH_O, "vector_string_T___len__(vector_string_T self) -> std::vector< std::string >::size_type"},
+	 { "vector_string_T___getslice__", _wrap_vector_string_T___getslice__, METH_VARARGS, "vector_string_T___getslice__(vector_string_T self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j) -> vector_string_T"},
+	 { "vector_string_T___setslice__", _wrap_vector_string_T___setslice__, METH_VARARGS, "\n"
+		"vector_string_T___setslice__(vector_string_T self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j)\n"
+		"vector_string_T___setslice__(vector_string_T self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j, vector_string_T v)\n"
 		""},
-	 { "vector_string_t___delslice__", _wrap_vector_string_t___delslice__, METH_VARARGS, "vector_string_t___delslice__(vector_string_t self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j)"},
-	 { "vector_string_t___delitem__", _wrap_vector_string_t___delitem__, METH_VARARGS, "\n"
-		"vector_string_t___delitem__(vector_string_t self, std::vector< std::string >::difference_type i)\n"
-		"vector_string_t___delitem__(vector_string_t self, SWIGPY_SLICEOBJECT * slice)\n"
+	 { "vector_string_T___delslice__", _wrap_vector_string_T___delslice__, METH_VARARGS, "vector_string_T___delslice__(vector_string_T self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j)"},
+	 { "vector_string_T___delitem__", _wrap_vector_string_T___delitem__, METH_VARARGS, "\n"
+		"vector_string_T___delitem__(vector_string_T self, std::vector< std::string >::difference_type i)\n"
+		"vector_string_T___delitem__(vector_string_T self, SWIGPY_SLICEOBJECT * slice)\n"
 		""},
-	 { "vector_string_t___getitem__", _wrap_vector_string_t___getitem__, METH_VARARGS, "\n"
-		"vector_string_t___getitem__(vector_string_t self, SWIGPY_SLICEOBJECT * slice) -> vector_string_t\n"
-		"vector_string_t___getitem__(vector_string_t self, std::vector< std::string >::difference_type i) -> std::vector< std::string >::value_type const &\n"
+	 { "vector_string_T___getitem__", _wrap_vector_string_T___getitem__, METH_VARARGS, "\n"
+		"vector_string_T___getitem__(vector_string_T self, SWIGPY_SLICEOBJECT * slice) -> vector_string_T\n"
+		"vector_string_T___getitem__(vector_string_T self, std::vector< std::string >::difference_type i) -> std::vector< std::string >::value_type const &\n"
 		""},
-	 { "vector_string_t___setitem__", _wrap_vector_string_t___setitem__, METH_VARARGS, "\n"
-		"vector_string_t___setitem__(vector_string_t self, SWIGPY_SLICEOBJECT * slice, vector_string_t v)\n"
-		"vector_string_t___setitem__(vector_string_t self, SWIGPY_SLICEOBJECT * slice)\n"
-		"vector_string_t___setitem__(vector_string_t self, std::vector< std::string >::difference_type i, std::vector< std::string >::value_type const & x)\n"
+	 { "vector_string_T___setitem__", _wrap_vector_string_T___setitem__, METH_VARARGS, "\n"
+		"vector_string_T___setitem__(vector_string_T self, SWIGPY_SLICEOBJECT * slice, vector_string_T v)\n"
+		"vector_string_T___setitem__(vector_string_T self, SWIGPY_SLICEOBJECT * slice)\n"
+		"vector_string_T___setitem__(vector_string_T self, std::vector< std::string >::difference_type i, std::vector< std::string >::value_type const & x)\n"
 		""},
-	 { "vector_string_t_pop", _wrap_vector_string_t_pop, METH_O, "vector_string_t_pop(vector_string_t self) -> std::vector< std::string >::value_type"},
-	 { "vector_string_t_append", _wrap_vector_string_t_append, METH_VARARGS, "vector_string_t_append(vector_string_t self, std::vector< std::string >::value_type const & x)"},
-	 { "vector_string_t_empty", _wrap_vector_string_t_empty, METH_O, "vector_string_t_empty(vector_string_t self) -> bool"},
-	 { "vector_string_t_size", _wrap_vector_string_t_size, METH_O, "vector_string_t_size(vector_string_t self) -> std::vector< std::string >::size_type"},
-	 { "vector_string_t_swap", _wrap_vector_string_t_swap, METH_VARARGS, "vector_string_t_swap(vector_string_t self, vector_string_t v)"},
-	 { "vector_string_t_begin", _wrap_vector_string_t_begin, METH_O, "vector_string_t_begin(vector_string_t self) -> std::vector< std::string >::iterator"},
-	 { "vector_string_t_end", _wrap_vector_string_t_end, METH_O, "vector_string_t_end(vector_string_t self) -> std::vector< std::string >::iterator"},
-	 { "vector_string_t_rbegin", _wrap_vector_string_t_rbegin, METH_O, "vector_string_t_rbegin(vector_string_t self) -> std::vector< std::string >::reverse_iterator"},
-	 { "vector_string_t_rend", _wrap_vector_string_t_rend, METH_O, "vector_string_t_rend(vector_string_t self) -> std::vector< std::string >::reverse_iterator"},
-	 { "vector_string_t_clear", _wrap_vector_string_t_clear, METH_O, "vector_string_t_clear(vector_string_t self)"},
-	 { "vector_string_t_get_allocator", _wrap_vector_string_t_get_allocator, METH_O, "vector_string_t_get_allocator(vector_string_t self) -> std::vector< std::string >::allocator_type"},
-	 { "vector_string_t_pop_back", _wrap_vector_string_t_pop_back, METH_O, "vector_string_t_pop_back(vector_string_t self)"},
-	 { "vector_string_t_erase", _wrap_vector_string_t_erase, METH_VARARGS, "\n"
-		"vector_string_t_erase(vector_string_t self, std::vector< std::string >::iterator pos) -> std::vector< std::string >::iterator\n"
-		"vector_string_t_erase(vector_string_t self, std::vector< std::string >::iterator first, std::vector< std::string >::iterator last) -> std::vector< std::string >::iterator\n"
+	 { "vector_string_T_pop", _wrap_vector_string_T_pop, METH_O, "vector_string_T_pop(vector_string_T self) -> std::vector< std::string >::value_type"},
+	 { "vector_string_T_append", _wrap_vector_string_T_append, METH_VARARGS, "vector_string_T_append(vector_string_T self, std::vector< std::string >::value_type const & x)"},
+	 { "vector_string_T_empty", _wrap_vector_string_T_empty, METH_O, "vector_string_T_empty(vector_string_T self) -> bool"},
+	 { "vector_string_T_size", _wrap_vector_string_T_size, METH_O, "vector_string_T_size(vector_string_T self) -> std::vector< std::string >::size_type"},
+	 { "vector_string_T_swap", _wrap_vector_string_T_swap, METH_VARARGS, "vector_string_T_swap(vector_string_T self, vector_string_T v)"},
+	 { "vector_string_T_begin", _wrap_vector_string_T_begin, METH_O, "vector_string_T_begin(vector_string_T self) -> std::vector< std::string >::iterator"},
+	 { "vector_string_T_end", _wrap_vector_string_T_end, METH_O, "vector_string_T_end(vector_string_T self) -> std::vector< std::string >::iterator"},
+	 { "vector_string_T_rbegin", _wrap_vector_string_T_rbegin, METH_O, "vector_string_T_rbegin(vector_string_T self) -> std::vector< std::string >::reverse_iterator"},
+	 { "vector_string_T_rend", _wrap_vector_string_T_rend, METH_O, "vector_string_T_rend(vector_string_T self) -> std::vector< std::string >::reverse_iterator"},
+	 { "vector_string_T_clear", _wrap_vector_string_T_clear, METH_O, "vector_string_T_clear(vector_string_T self)"},
+	 { "vector_string_T_get_allocator", _wrap_vector_string_T_get_allocator, METH_O, "vector_string_T_get_allocator(vector_string_T self) -> std::vector< std::string >::allocator_type"},
+	 { "vector_string_T_pop_back", _wrap_vector_string_T_pop_back, METH_O, "vector_string_T_pop_back(vector_string_T self)"},
+	 { "vector_string_T_erase", _wrap_vector_string_T_erase, METH_VARARGS, "\n"
+		"vector_string_T_erase(vector_string_T self, std::vector< std::string >::iterator pos) -> std::vector< std::string >::iterator\n"
+		"vector_string_T_erase(vector_string_T self, std::vector< std::string >::iterator first, std::vector< std::string >::iterator last) -> std::vector< std::string >::iterator\n"
 		""},
-	 { "new_vector_string_t", _wrap_new_vector_string_t, METH_VARARGS, "\n"
-		"vector_string_t()\n"
-		"vector_string_t(vector_string_t other)\n"
-		"vector_string_t(std::vector< std::string >::size_type size)\n"
-		"new_vector_string_t(std::vector< std::string >::size_type size, std::vector< std::string >::value_type const & value) -> vector_string_t\n"
+	 { "new_vector_string_T", _wrap_new_vector_string_T, METH_VARARGS, "\n"
+		"vector_string_T()\n"
+		"vector_string_T(vector_string_T other)\n"
+		"vector_string_T(std::vector< std::string >::size_type size)\n"
+		"new_vector_string_T(std::vector< std::string >::size_type size, std::vector< std::string >::value_type const & value) -> vector_string_T\n"
 		""},
-	 { "vector_string_t_push_back", _wrap_vector_string_t_push_back, METH_VARARGS, "vector_string_t_push_back(vector_string_t self, std::vector< std::string >::value_type const & x)"},
-	 { "vector_string_t_front", _wrap_vector_string_t_front, METH_O, "vector_string_t_front(vector_string_t self) -> std::vector< std::string >::value_type const &"},
-	 { "vector_string_t_back", _wrap_vector_string_t_back, METH_O, "vector_string_t_back(vector_string_t self) -> std::vector< std::string >::value_type const &"},
-	 { "vector_string_t_assign", _wrap_vector_string_t_assign, METH_VARARGS, "vector_string_t_assign(vector_string_t self, std::vector< std::string >::size_type n, std::vector< std::string >::value_type const & x)"},
-	 { "vector_string_t_resize", _wrap_vector_string_t_resize, METH_VARARGS, "\n"
-		"vector_string_t_resize(vector_string_t self, std::vector< std::string >::size_type new_size)\n"
-		"vector_string_t_resize(vector_string_t self, std::vector< std::string >::size_type new_size, std::vector< std::string >::value_type const & x)\n"
+	 { "vector_string_T_push_back", _wrap_vector_string_T_push_back, METH_VARARGS, "vector_string_T_push_back(vector_string_T self, std::vector< std::string >::value_type const & x)"},
+	 { "vector_string_T_front", _wrap_vector_string_T_front, METH_O, "vector_string_T_front(vector_string_T self) -> std::vector< std::string >::value_type const &"},
+	 { "vector_string_T_back", _wrap_vector_string_T_back, METH_O, "vector_string_T_back(vector_string_T self) -> std::vector< std::string >::value_type const &"},
+	 { "vector_string_T_assign", _wrap_vector_string_T_assign, METH_VARARGS, "vector_string_T_assign(vector_string_T self, std::vector< std::string >::size_type n, std::vector< std::string >::value_type const & x)"},
+	 { "vector_string_T_resize", _wrap_vector_string_T_resize, METH_VARARGS, "\n"
+		"vector_string_T_resize(vector_string_T self, std::vector< std::string >::size_type new_size)\n"
+		"vector_string_T_resize(vector_string_T self, std::vector< std::string >::size_type new_size, std::vector< std::string >::value_type const & x)\n"
 		""},
-	 { "vector_string_t_insert", _wrap_vector_string_t_insert, METH_VARARGS, "\n"
-		"vector_string_t_insert(vector_string_t self, std::vector< std::string >::iterator pos, std::vector< std::string >::value_type const & x) -> std::vector< std::string >::iterator\n"
-		"vector_string_t_insert(vector_string_t self, std::vector< std::string >::iterator pos, std::vector< std::string >::size_type n, std::vector< std::string >::value_type const & x)\n"
+	 { "vector_string_T_insert", _wrap_vector_string_T_insert, METH_VARARGS, "\n"
+		"vector_string_T_insert(vector_string_T self, std::vector< std::string >::iterator pos, std::vector< std::string >::value_type const & x) -> std::vector< std::string >::iterator\n"
+		"vector_string_T_insert(vector_string_T self, std::vector< std::string >::iterator pos, std::vector< std::string >::size_type n, std::vector< std::string >::value_type const & x)\n"
 		""},
-	 { "vector_string_t_reserve", _wrap_vector_string_t_reserve, METH_VARARGS, "vector_string_t_reserve(vector_string_t self, std::vector< std::string >::size_type n)"},
-	 { "vector_string_t_capacity", _wrap_vector_string_t_capacity, METH_O, "vector_string_t_capacity(vector_string_t self) -> std::vector< std::string >::size_type"},
-	 { "delete_vector_string_t", _wrap_delete_vector_string_t, METH_O, "delete_vector_string_t(vector_string_t self)"},
-	 { "vector_string_t_swigregister", vector_string_t_swigregister, METH_O, NULL},
-	 { "vector_string_t_swiginit", vector_string_t_swiginit, METH_VARARGS, NULL},
-	 { "map_string_double_t_iterator", _wrap_map_string_double_t_iterator, METH_O, "map_string_double_t_iterator(map_string_double_t self) -> SwigPyIterator"},
-	 { "map_string_double_t___nonzero__", _wrap_map_string_double_t___nonzero__, METH_O, "map_string_double_t___nonzero__(map_string_double_t self) -> bool"},
-	 { "map_string_double_t___bool__", _wrap_map_string_double_t___bool__, METH_O, "map_string_double_t___bool__(map_string_double_t self) -> bool"},
-	 { "map_string_double_t___len__", _wrap_map_string_double_t___len__, METH_O, "map_string_double_t___len__(map_string_double_t self) -> std::map< std::string,double >::size_type"},
-	 { "map_string_double_t___getitem__", _wrap_map_string_double_t___getitem__, METH_VARARGS, "map_string_double_t___getitem__(map_string_double_t self, std::map< std::string,double >::key_type const & key) -> std::map< std::string,double >::mapped_type const &"},
-	 { "map_string_double_t___delitem__", _wrap_map_string_double_t___delitem__, METH_VARARGS, "map_string_double_t___delitem__(map_string_double_t self, std::map< std::string,double >::key_type const & key)"},
-	 { "map_string_double_t_has_key", _wrap_map_string_double_t_has_key, METH_VARARGS, "map_string_double_t_has_key(map_string_double_t self, std::map< std::string,double >::key_type const & key) -> bool"},
-	 { "map_string_double_t_keys", _wrap_map_string_double_t_keys, METH_O, "map_string_double_t_keys(map_string_double_t self) -> PyObject *"},
-	 { "map_string_double_t_values", _wrap_map_string_double_t_values, METH_O, "map_string_double_t_values(map_string_double_t self) -> PyObject *"},
-	 { "map_string_double_t_items", _wrap_map_string_double_t_items, METH_O, "map_string_double_t_items(map_string_double_t self) -> PyObject *"},
-	 { "map_string_double_t___contains__", _wrap_map_string_double_t___contains__, METH_VARARGS, "map_string_double_t___contains__(map_string_double_t self, std::map< std::string,double >::key_type const & key) -> bool"},
-	 { "map_string_double_t_key_iterator", _wrap_map_string_double_t_key_iterator, METH_O, "map_string_double_t_key_iterator(map_string_double_t self) -> SwigPyIterator"},
-	 { "map_string_double_t_value_iterator", _wrap_map_string_double_t_value_iterator, METH_O, "map_string_double_t_value_iterator(map_string_double_t self) -> SwigPyIterator"},
-	 { "map_string_double_t___setitem__", _wrap_map_string_double_t___setitem__, METH_VARARGS, "\n"
-		"map_string_double_t___setitem__(map_string_double_t self, std::map< std::string,double >::key_type const & key)\n"
-		"map_string_double_t___setitem__(map_string_double_t self, std::map< std::string,double >::key_type const & key, std::map< std::string,double >::mapped_type const & x)\n"
+	 { "vector_string_T_reserve", _wrap_vector_string_T_reserve, METH_VARARGS, "vector_string_T_reserve(vector_string_T self, std::vector< std::string >::size_type n)"},
+	 { "vector_string_T_capacity", _wrap_vector_string_T_capacity, METH_O, "vector_string_T_capacity(vector_string_T self) -> std::vector< std::string >::size_type"},
+	 { "delete_vector_string_T", _wrap_delete_vector_string_T, METH_O, "delete_vector_string_T(vector_string_T self)"},
+	 { "vector_string_T_swigregister", vector_string_T_swigregister, METH_O, NULL},
+	 { "vector_string_T_swiginit", vector_string_T_swiginit, METH_VARARGS, NULL},
+	 { "map_string_double_T_iterator", _wrap_map_string_double_T_iterator, METH_O, "map_string_double_T_iterator(map_string_double_T self) -> SwigPyIterator"},
+	 { "map_string_double_T___nonzero__", _wrap_map_string_double_T___nonzero__, METH_O, "map_string_double_T___nonzero__(map_string_double_T self) -> bool"},
+	 { "map_string_double_T___bool__", _wrap_map_string_double_T___bool__, METH_O, "map_string_double_T___bool__(map_string_double_T self) -> bool"},
+	 { "map_string_double_T___len__", _wrap_map_string_double_T___len__, METH_O, "map_string_double_T___len__(map_string_double_T self) -> std::map< std::string,double >::size_type"},
+	 { "map_string_double_T___getitem__", _wrap_map_string_double_T___getitem__, METH_VARARGS, "map_string_double_T___getitem__(map_string_double_T self, std::map< std::string,double >::key_type const & key) -> std::map< std::string,double >::mapped_type const &"},
+	 { "map_string_double_T___delitem__", _wrap_map_string_double_T___delitem__, METH_VARARGS, "map_string_double_T___delitem__(map_string_double_T self, std::map< std::string,double >::key_type const & key)"},
+	 { "map_string_double_T_has_key", _wrap_map_string_double_T_has_key, METH_VARARGS, "map_string_double_T_has_key(map_string_double_T self, std::map< std::string,double >::key_type const & key) -> bool"},
+	 { "map_string_double_T_keys", _wrap_map_string_double_T_keys, METH_O, "map_string_double_T_keys(map_string_double_T self) -> PyObject *"},
+	 { "map_string_double_T_values", _wrap_map_string_double_T_values, METH_O, "map_string_double_T_values(map_string_double_T self) -> PyObject *"},
+	 { "map_string_double_T_items", _wrap_map_string_double_T_items, METH_O, "map_string_double_T_items(map_string_double_T self) -> PyObject *"},
+	 { "map_string_double_T___contains__", _wrap_map_string_double_T___contains__, METH_VARARGS, "map_string_double_T___contains__(map_string_double_T self, std::map< std::string,double >::key_type const & key) -> bool"},
+	 { "map_string_double_T_key_iterator", _wrap_map_string_double_T_key_iterator, METH_O, "map_string_double_T_key_iterator(map_string_double_T self) -> SwigPyIterator"},
+	 { "map_string_double_T_value_iterator", _wrap_map_string_double_T_value_iterator, METH_O, "map_string_double_T_value_iterator(map_string_double_T self) -> SwigPyIterator"},
+	 { "map_string_double_T___setitem__", _wrap_map_string_double_T___setitem__, METH_VARARGS, "\n"
+		"map_string_double_T___setitem__(map_string_double_T self, std::map< std::string,double >::key_type const & key)\n"
+		"map_string_double_T___setitem__(map_string_double_T self, std::map< std::string,double >::key_type const & key, std::map< std::string,double >::mapped_type const & x)\n"
 		""},
-	 { "map_string_double_t_asdict", _wrap_map_string_double_t_asdict, METH_O, "map_string_double_t_asdict(map_string_double_t self) -> PyObject *"},
-	 { "new_map_string_double_t", _wrap_new_map_string_double_t, METH_VARARGS, "\n"
-		"map_string_double_t(std::less< std::string > const & other)\n"
-		"map_string_double_t()\n"
-		"new_map_string_double_t(map_string_double_t other) -> map_string_double_t\n"
+	 { "map_string_double_T_asdict", _wrap_map_string_double_T_asdict, METH_O, "map_string_double_T_asdict(map_string_double_T self) -> PyObject *"},
+	 { "new_map_string_double_T", _wrap_new_map_string_double_T, METH_VARARGS, "\n"
+		"map_string_double_T(std::less< std::string > const & other)\n"
+		"map_string_double_T()\n"
+		"new_map_string_double_T(map_string_double_T other) -> map_string_double_T\n"
 		""},
-	 { "map_string_double_t_empty", _wrap_map_string_double_t_empty, METH_O, "map_string_double_t_empty(map_string_double_t self) -> bool"},
-	 { "map_string_double_t_size", _wrap_map_string_double_t_size, METH_O, "map_string_double_t_size(map_string_double_t self) -> std::map< std::string,double >::size_type"},
-	 { "map_string_double_t_swap", _wrap_map_string_double_t_swap, METH_VARARGS, "map_string_double_t_swap(map_string_double_t self, map_string_double_t v)"},
-	 { "map_string_double_t_begin", _wrap_map_string_double_t_begin, METH_O, "map_string_double_t_begin(map_string_double_t self) -> std::map< std::string,double >::iterator"},
-	 { "map_string_double_t_end", _wrap_map_string_double_t_end, METH_O, "map_string_double_t_end(map_string_double_t self) -> std::map< std::string,double >::iterator"},
-	 { "map_string_double_t_rbegin", _wrap_map_string_double_t_rbegin, METH_O, "map_string_double_t_rbegin(map_string_double_t self) -> std::map< std::string,double >::reverse_iterator"},
-	 { "map_string_double_t_rend", _wrap_map_string_double_t_rend, METH_O, "map_string_double_t_rend(map_string_double_t self) -> std::map< std::string,double >::reverse_iterator"},
-	 { "map_string_double_t_clear", _wrap_map_string_double_t_clear, METH_O, "map_string_double_t_clear(map_string_double_t self)"},
-	 { "map_string_double_t_get_allocator", _wrap_map_string_double_t_get_allocator, METH_O, "map_string_double_t_get_allocator(map_string_double_t self) -> std::map< std::string,double >::allocator_type"},
-	 { "map_string_double_t_count", _wrap_map_string_double_t_count, METH_VARARGS, "map_string_double_t_count(map_string_double_t self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::size_type"},
-	 { "map_string_double_t_erase", _wrap_map_string_double_t_erase, METH_VARARGS, "\n"
-		"map_string_double_t_erase(map_string_double_t self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::size_type\n"
-		"map_string_double_t_erase(map_string_double_t self, std::map< std::string,double >::iterator position)\n"
-		"map_string_double_t_erase(map_string_double_t self, std::map< std::string,double >::iterator first, std::map< std::string,double >::iterator last)\n"
+	 { "map_string_double_T_empty", _wrap_map_string_double_T_empty, METH_O, "map_string_double_T_empty(map_string_double_T self) -> bool"},
+	 { "map_string_double_T_size", _wrap_map_string_double_T_size, METH_O, "map_string_double_T_size(map_string_double_T self) -> std::map< std::string,double >::size_type"},
+	 { "map_string_double_T_swap", _wrap_map_string_double_T_swap, METH_VARARGS, "map_string_double_T_swap(map_string_double_T self, map_string_double_T v)"},
+	 { "map_string_double_T_begin", _wrap_map_string_double_T_begin, METH_O, "map_string_double_T_begin(map_string_double_T self) -> std::map< std::string,double >::iterator"},
+	 { "map_string_double_T_end", _wrap_map_string_double_T_end, METH_O, "map_string_double_T_end(map_string_double_T self) -> std::map< std::string,double >::iterator"},
+	 { "map_string_double_T_rbegin", _wrap_map_string_double_T_rbegin, METH_O, "map_string_double_T_rbegin(map_string_double_T self) -> std::map< std::string,double >::reverse_iterator"},
+	 { "map_string_double_T_rend", _wrap_map_string_double_T_rend, METH_O, "map_string_double_T_rend(map_string_double_T self) -> std::map< std::string,double >::reverse_iterator"},
+	 { "map_string_double_T_clear", _wrap_map_string_double_T_clear, METH_O, "map_string_double_T_clear(map_string_double_T self)"},
+	 { "map_string_double_T_get_allocator", _wrap_map_string_double_T_get_allocator, METH_O, "map_string_double_T_get_allocator(map_string_double_T self) -> std::map< std::string,double >::allocator_type"},
+	 { "map_string_double_T_count", _wrap_map_string_double_T_count, METH_VARARGS, "map_string_double_T_count(map_string_double_T self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::size_type"},
+	 { "map_string_double_T_erase", _wrap_map_string_double_T_erase, METH_VARARGS, "\n"
+		"map_string_double_T_erase(map_string_double_T self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::size_type\n"
+		"map_string_double_T_erase(map_string_double_T self, std::map< std::string,double >::iterator position)\n"
+		"map_string_double_T_erase(map_string_double_T self, std::map< std::string,double >::iterator first, std::map< std::string,double >::iterator last)\n"
 		""},
-	 { "map_string_double_t_find", _wrap_map_string_double_t_find, METH_VARARGS, "map_string_double_t_find(map_string_double_t self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"},
-	 { "map_string_double_t_lower_bound", _wrap_map_string_double_t_lower_bound, METH_VARARGS, "map_string_double_t_lower_bound(map_string_double_t self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"},
-	 { "map_string_double_t_upper_bound", _wrap_map_string_double_t_upper_bound, METH_VARARGS, "map_string_double_t_upper_bound(map_string_double_t self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"},
-	 { "delete_map_string_double_t", _wrap_delete_map_string_double_t, METH_O, "delete_map_string_double_t(map_string_double_t self)"},
-	 { "map_string_double_t_swigregister", map_string_double_t_swigregister, METH_O, NULL},
-	 { "map_string_double_t_swiginit", map_string_double_t_swiginit, METH_VARARGS, NULL},
-	 { "new_pvacuum_double_t", _wrap_new_pvacuum_double_t, METH_VARARGS, "\n"
-		"pvacuum_double_t()\n"
-		"pvacuum_double_t(double first, double second)\n"
-		"new_pvacuum_double_t(pvacuum_double_t other) -> pvacuum_double_t\n"
+	 { "map_string_double_T_find", _wrap_map_string_double_T_find, METH_VARARGS, "map_string_double_T_find(map_string_double_T self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"},
+	 { "map_string_double_T_lower_bound", _wrap_map_string_double_T_lower_bound, METH_VARARGS, "map_string_double_T_lower_bound(map_string_double_T self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"},
+	 { "map_string_double_T_upper_bound", _wrap_map_string_double_T_upper_bound, METH_VARARGS, "map_string_double_T_upper_bound(map_string_double_T self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"},
+	 { "delete_map_string_double_T", _wrap_delete_map_string_double_T, METH_O, "delete_map_string_double_T(map_string_double_T self)"},
+	 { "map_string_double_T_swigregister", map_string_double_T_swigregister, METH_O, NULL},
+	 { "map_string_double_T_swiginit", map_string_double_T_swiginit, METH_VARARGS, NULL},
+	 { "new_pvacuum_double_T", _wrap_new_pvacuum_double_T, METH_VARARGS, "\n"
+		"pvacuum_double_T()\n"
+		"pvacuum_double_T(double first, double second)\n"
+		"new_pvacuum_double_T(pvacuum_double_T other) -> pvacuum_double_T\n"
 		""},
-	 { "pvacuum_double_t_first_set", _wrap_pvacuum_double_t_first_set, METH_VARARGS, "pvacuum_double_t_first_set(pvacuum_double_t self, double first)"},
-	 { "pvacuum_double_t_first_get", _wrap_pvacuum_double_t_first_get, METH_O, "pvacuum_double_t_first_get(pvacuum_double_t self) -> double"},
-	 { "pvacuum_double_t_second_set", _wrap_pvacuum_double_t_second_set, METH_VARARGS, "pvacuum_double_t_second_set(pvacuum_double_t self, double second)"},
-	 { "pvacuum_double_t_second_get", _wrap_pvacuum_double_t_second_get, METH_O, "pvacuum_double_t_second_get(pvacuum_double_t self) -> double"},
-	 { "delete_pvacuum_double_t", _wrap_delete_pvacuum_double_t, METH_O, "delete_pvacuum_double_t(pvacuum_double_t self)"},
-	 { "pvacuum_double_t_swigregister", pvacuum_double_t_swigregister, METH_O, NULL},
-	 { "pvacuum_double_t_swiginit", pvacuum_double_t_swiginit, METH_VARARGS, NULL},
-	 { "vector_pvacuum_double_t_iterator", _wrap_vector_pvacuum_double_t_iterator, METH_O, "vector_pvacuum_double_t_iterator(vector_pvacuum_double_t self) -> SwigPyIterator"},
-	 { "vector_pvacuum_double_t___nonzero__", _wrap_vector_pvacuum_double_t___nonzero__, METH_O, "vector_pvacuum_double_t___nonzero__(vector_pvacuum_double_t self) -> bool"},
-	 { "vector_pvacuum_double_t___bool__", _wrap_vector_pvacuum_double_t___bool__, METH_O, "vector_pvacuum_double_t___bool__(vector_pvacuum_double_t self) -> bool"},
-	 { "vector_pvacuum_double_t___len__", _wrap_vector_pvacuum_double_t___len__, METH_O, "vector_pvacuum_double_t___len__(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::size_type"},
-	 { "vector_pvacuum_double_t___getslice__", _wrap_vector_pvacuum_double_t___getslice__, METH_VARARGS, "vector_pvacuum_double_t___getslice__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j) -> vector_pvacuum_double_t"},
-	 { "vector_pvacuum_double_t___setslice__", _wrap_vector_pvacuum_double_t___setslice__, METH_VARARGS, "\n"
-		"vector_pvacuum_double_t___setslice__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j)\n"
-		"vector_pvacuum_double_t___setslice__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j, vector_pvacuum_double_t v)\n"
+	 { "pvacuum_double_T_first_set", _wrap_pvacuum_double_T_first_set, METH_VARARGS, "pvacuum_double_T_first_set(pvacuum_double_T self, double first)"},
+	 { "pvacuum_double_T_first_get", _wrap_pvacuum_double_T_first_get, METH_O, "pvacuum_double_T_first_get(pvacuum_double_T self) -> double"},
+	 { "pvacuum_double_T_second_set", _wrap_pvacuum_double_T_second_set, METH_VARARGS, "pvacuum_double_T_second_set(pvacuum_double_T self, double second)"},
+	 { "pvacuum_double_T_second_get", _wrap_pvacuum_double_T_second_get, METH_O, "pvacuum_double_T_second_get(pvacuum_double_T self) -> double"},
+	 { "delete_pvacuum_double_T", _wrap_delete_pvacuum_double_T, METH_O, "delete_pvacuum_double_T(pvacuum_double_T self)"},
+	 { "pvacuum_double_T_swigregister", pvacuum_double_T_swigregister, METH_O, NULL},
+	 { "pvacuum_double_T_swiginit", pvacuum_double_T_swiginit, METH_VARARGS, NULL},
+	 { "vector_pvacuum_double_T_iterator", _wrap_vector_pvacuum_double_T_iterator, METH_O, "vector_pvacuum_double_T_iterator(vector_pvacuum_double_T self) -> SwigPyIterator"},
+	 { "vector_pvacuum_double_T___nonzero__", _wrap_vector_pvacuum_double_T___nonzero__, METH_O, "vector_pvacuum_double_T___nonzero__(vector_pvacuum_double_T self) -> bool"},
+	 { "vector_pvacuum_double_T___bool__", _wrap_vector_pvacuum_double_T___bool__, METH_O, "vector_pvacuum_double_T___bool__(vector_pvacuum_double_T self) -> bool"},
+	 { "vector_pvacuum_double_T___len__", _wrap_vector_pvacuum_double_T___len__, METH_O, "vector_pvacuum_double_T___len__(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::size_type"},
+	 { "vector_pvacuum_double_T___getslice__", _wrap_vector_pvacuum_double_T___getslice__, METH_VARARGS, "vector_pvacuum_double_T___getslice__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j) -> vector_pvacuum_double_T"},
+	 { "vector_pvacuum_double_T___setslice__", _wrap_vector_pvacuum_double_T___setslice__, METH_VARARGS, "\n"
+		"vector_pvacuum_double_T___setslice__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j)\n"
+		"vector_pvacuum_double_T___setslice__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j, vector_pvacuum_double_T v)\n"
 		""},
-	 { "vector_pvacuum_double_t___delslice__", _wrap_vector_pvacuum_double_t___delslice__, METH_VARARGS, "vector_pvacuum_double_t___delslice__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j)"},
-	 { "vector_pvacuum_double_t___delitem__", _wrap_vector_pvacuum_double_t___delitem__, METH_VARARGS, "\n"
-		"vector_pvacuum_double_t___delitem__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i)\n"
-		"vector_pvacuum_double_t___delitem__(vector_pvacuum_double_t self, SWIGPY_SLICEOBJECT * slice)\n"
+	 { "vector_pvacuum_double_T___delslice__", _wrap_vector_pvacuum_double_T___delslice__, METH_VARARGS, "vector_pvacuum_double_T___delslice__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j)"},
+	 { "vector_pvacuum_double_T___delitem__", _wrap_vector_pvacuum_double_T___delitem__, METH_VARARGS, "\n"
+		"vector_pvacuum_double_T___delitem__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i)\n"
+		"vector_pvacuum_double_T___delitem__(vector_pvacuum_double_T self, SWIGPY_SLICEOBJECT * slice)\n"
 		""},
-	 { "vector_pvacuum_double_t___getitem__", _wrap_vector_pvacuum_double_t___getitem__, METH_VARARGS, "\n"
-		"vector_pvacuum_double_t___getitem__(vector_pvacuum_double_t self, SWIGPY_SLICEOBJECT * slice) -> vector_pvacuum_double_t\n"
-		"vector_pvacuum_double_t___getitem__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i) -> pvacuum_double_t\n"
+	 { "vector_pvacuum_double_T___getitem__", _wrap_vector_pvacuum_double_T___getitem__, METH_VARARGS, "\n"
+		"vector_pvacuum_double_T___getitem__(vector_pvacuum_double_T self, SWIGPY_SLICEOBJECT * slice) -> vector_pvacuum_double_T\n"
+		"vector_pvacuum_double_T___getitem__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i) -> pvacuum_double_T\n"
 		""},
-	 { "vector_pvacuum_double_t___setitem__", _wrap_vector_pvacuum_double_t___setitem__, METH_VARARGS, "\n"
-		"vector_pvacuum_double_t___setitem__(vector_pvacuum_double_t self, SWIGPY_SLICEOBJECT * slice, vector_pvacuum_double_t v)\n"
-		"vector_pvacuum_double_t___setitem__(vector_pvacuum_double_t self, SWIGPY_SLICEOBJECT * slice)\n"
-		"vector_pvacuum_double_t___setitem__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i, pvacuum_double_t x)\n"
+	 { "vector_pvacuum_double_T___setitem__", _wrap_vector_pvacuum_double_T___setitem__, METH_VARARGS, "\n"
+		"vector_pvacuum_double_T___setitem__(vector_pvacuum_double_T self, SWIGPY_SLICEOBJECT * slice, vector_pvacuum_double_T v)\n"
+		"vector_pvacuum_double_T___setitem__(vector_pvacuum_double_T self, SWIGPY_SLICEOBJECT * slice)\n"
+		"vector_pvacuum_double_T___setitem__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i, pvacuum_double_T x)\n"
 		""},
-	 { "vector_pvacuum_double_t_pop", _wrap_vector_pvacuum_double_t_pop, METH_O, "vector_pvacuum_double_t_pop(vector_pvacuum_double_t self) -> pvacuum_double_t"},
-	 { "vector_pvacuum_double_t_append", _wrap_vector_pvacuum_double_t_append, METH_VARARGS, "vector_pvacuum_double_t_append(vector_pvacuum_double_t self, pvacuum_double_t x)"},
-	 { "vector_pvacuum_double_t_empty", _wrap_vector_pvacuum_double_t_empty, METH_O, "vector_pvacuum_double_t_empty(vector_pvacuum_double_t self) -> bool"},
-	 { "vector_pvacuum_double_t_size", _wrap_vector_pvacuum_double_t_size, METH_O, "vector_pvacuum_double_t_size(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::size_type"},
-	 { "vector_pvacuum_double_t_swap", _wrap_vector_pvacuum_double_t_swap, METH_VARARGS, "vector_pvacuum_double_t_swap(vector_pvacuum_double_t self, vector_pvacuum_double_t v)"},
-	 { "vector_pvacuum_double_t_begin", _wrap_vector_pvacuum_double_t_begin, METH_O, "vector_pvacuum_double_t_begin(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::iterator"},
-	 { "vector_pvacuum_double_t_end", _wrap_vector_pvacuum_double_t_end, METH_O, "vector_pvacuum_double_t_end(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::iterator"},
-	 { "vector_pvacuum_double_t_rbegin", _wrap_vector_pvacuum_double_t_rbegin, METH_O, "vector_pvacuum_double_t_rbegin(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::reverse_iterator"},
-	 { "vector_pvacuum_double_t_rend", _wrap_vector_pvacuum_double_t_rend, METH_O, "vector_pvacuum_double_t_rend(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::reverse_iterator"},
-	 { "vector_pvacuum_double_t_clear", _wrap_vector_pvacuum_double_t_clear, METH_O, "vector_pvacuum_double_t_clear(vector_pvacuum_double_t self)"},
-	 { "vector_pvacuum_double_t_get_allocator", _wrap_vector_pvacuum_double_t_get_allocator, METH_O, "vector_pvacuum_double_t_get_allocator(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::allocator_type"},
-	 { "vector_pvacuum_double_t_pop_back", _wrap_vector_pvacuum_double_t_pop_back, METH_O, "vector_pvacuum_double_t_pop_back(vector_pvacuum_double_t self)"},
-	 { "vector_pvacuum_double_t_erase", _wrap_vector_pvacuum_double_t_erase, METH_VARARGS, "\n"
-		"vector_pvacuum_double_t_erase(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::iterator pos) -> std::vector< std::pair< double,double > >::iterator\n"
-		"vector_pvacuum_double_t_erase(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::iterator first, std::vector< std::pair< double,double > >::iterator last) -> std::vector< std::pair< double,double > >::iterator\n"
+	 { "vector_pvacuum_double_T_pop", _wrap_vector_pvacuum_double_T_pop, METH_O, "vector_pvacuum_double_T_pop(vector_pvacuum_double_T self) -> pvacuum_double_T"},
+	 { "vector_pvacuum_double_T_append", _wrap_vector_pvacuum_double_T_append, METH_VARARGS, "vector_pvacuum_double_T_append(vector_pvacuum_double_T self, pvacuum_double_T x)"},
+	 { "vector_pvacuum_double_T_empty", _wrap_vector_pvacuum_double_T_empty, METH_O, "vector_pvacuum_double_T_empty(vector_pvacuum_double_T self) -> bool"},
+	 { "vector_pvacuum_double_T_size", _wrap_vector_pvacuum_double_T_size, METH_O, "vector_pvacuum_double_T_size(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::size_type"},
+	 { "vector_pvacuum_double_T_swap", _wrap_vector_pvacuum_double_T_swap, METH_VARARGS, "vector_pvacuum_double_T_swap(vector_pvacuum_double_T self, vector_pvacuum_double_T v)"},
+	 { "vector_pvacuum_double_T_begin", _wrap_vector_pvacuum_double_T_begin, METH_O, "vector_pvacuum_double_T_begin(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::iterator"},
+	 { "vector_pvacuum_double_T_end", _wrap_vector_pvacuum_double_T_end, METH_O, "vector_pvacuum_double_T_end(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::iterator"},
+	 { "vector_pvacuum_double_T_rbegin", _wrap_vector_pvacuum_double_T_rbegin, METH_O, "vector_pvacuum_double_T_rbegin(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::reverse_iterator"},
+	 { "vector_pvacuum_double_T_rend", _wrap_vector_pvacuum_double_T_rend, METH_O, "vector_pvacuum_double_T_rend(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::reverse_iterator"},
+	 { "vector_pvacuum_double_T_clear", _wrap_vector_pvacuum_double_T_clear, METH_O, "vector_pvacuum_double_T_clear(vector_pvacuum_double_T self)"},
+	 { "vector_pvacuum_double_T_get_allocator", _wrap_vector_pvacuum_double_T_get_allocator, METH_O, "vector_pvacuum_double_T_get_allocator(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::allocator_type"},
+	 { "vector_pvacuum_double_T_pop_back", _wrap_vector_pvacuum_double_T_pop_back, METH_O, "vector_pvacuum_double_T_pop_back(vector_pvacuum_double_T self)"},
+	 { "vector_pvacuum_double_T_erase", _wrap_vector_pvacuum_double_T_erase, METH_VARARGS, "\n"
+		"vector_pvacuum_double_T_erase(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::iterator pos) -> std::vector< std::pair< double,double > >::iterator\n"
+		"vector_pvacuum_double_T_erase(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::iterator first, std::vector< std::pair< double,double > >::iterator last) -> std::vector< std::pair< double,double > >::iterator\n"
 		""},
-	 { "new_vector_pvacuum_double_t", _wrap_new_vector_pvacuum_double_t, METH_VARARGS, "\n"
-		"vector_pvacuum_double_t()\n"
-		"vector_pvacuum_double_t(vector_pvacuum_double_t other)\n"
-		"vector_pvacuum_double_t(std::vector< std::pair< double,double > >::size_type size)\n"
-		"new_vector_pvacuum_double_t(std::vector< std::pair< double,double > >::size_type size, pvacuum_double_t value) -> vector_pvacuum_double_t\n"
+	 { "new_vector_pvacuum_double_T", _wrap_new_vector_pvacuum_double_T, METH_VARARGS, "\n"
+		"vector_pvacuum_double_T()\n"
+		"vector_pvacuum_double_T(vector_pvacuum_double_T other)\n"
+		"vector_pvacuum_double_T(std::vector< std::pair< double,double > >::size_type size)\n"
+		"new_vector_pvacuum_double_T(std::vector< std::pair< double,double > >::size_type size, pvacuum_double_T value) -> vector_pvacuum_double_T\n"
 		""},
-	 { "vector_pvacuum_double_t_push_back", _wrap_vector_pvacuum_double_t_push_back, METH_VARARGS, "vector_pvacuum_double_t_push_back(vector_pvacuum_double_t self, pvacuum_double_t x)"},
-	 { "vector_pvacuum_double_t_front", _wrap_vector_pvacuum_double_t_front, METH_O, "vector_pvacuum_double_t_front(vector_pvacuum_double_t self) -> pvacuum_double_t"},
-	 { "vector_pvacuum_double_t_back", _wrap_vector_pvacuum_double_t_back, METH_O, "vector_pvacuum_double_t_back(vector_pvacuum_double_t self) -> pvacuum_double_t"},
-	 { "vector_pvacuum_double_t_assign", _wrap_vector_pvacuum_double_t_assign, METH_VARARGS, "vector_pvacuum_double_t_assign(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::size_type n, pvacuum_double_t x)"},
-	 { "vector_pvacuum_double_t_resize", _wrap_vector_pvacuum_double_t_resize, METH_VARARGS, "\n"
-		"vector_pvacuum_double_t_resize(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::size_type new_size)\n"
-		"vector_pvacuum_double_t_resize(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::size_type new_size, pvacuum_double_t x)\n"
+	 { "vector_pvacuum_double_T_push_back", _wrap_vector_pvacuum_double_T_push_back, METH_VARARGS, "vector_pvacuum_double_T_push_back(vector_pvacuum_double_T self, pvacuum_double_T x)"},
+	 { "vector_pvacuum_double_T_front", _wrap_vector_pvacuum_double_T_front, METH_O, "vector_pvacuum_double_T_front(vector_pvacuum_double_T self) -> pvacuum_double_T"},
+	 { "vector_pvacuum_double_T_back", _wrap_vector_pvacuum_double_T_back, METH_O, "vector_pvacuum_double_T_back(vector_pvacuum_double_T self) -> pvacuum_double_T"},
+	 { "vector_pvacuum_double_T_assign", _wrap_vector_pvacuum_double_T_assign, METH_VARARGS, "vector_pvacuum_double_T_assign(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::size_type n, pvacuum_double_T x)"},
+	 { "vector_pvacuum_double_T_resize", _wrap_vector_pvacuum_double_T_resize, METH_VARARGS, "\n"
+		"vector_pvacuum_double_T_resize(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::size_type new_size)\n"
+		"vector_pvacuum_double_T_resize(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::size_type new_size, pvacuum_double_T x)\n"
 		""},
-	 { "vector_pvacuum_double_t_insert", _wrap_vector_pvacuum_double_t_insert, METH_VARARGS, "\n"
-		"vector_pvacuum_double_t_insert(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::iterator pos, pvacuum_double_t x) -> std::vector< std::pair< double,double > >::iterator\n"
-		"vector_pvacuum_double_t_insert(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::iterator pos, std::vector< std::pair< double,double > >::size_type n, pvacuum_double_t x)\n"
+	 { "vector_pvacuum_double_T_insert", _wrap_vector_pvacuum_double_T_insert, METH_VARARGS, "\n"
+		"vector_pvacuum_double_T_insert(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::iterator pos, pvacuum_double_T x) -> std::vector< std::pair< double,double > >::iterator\n"
+		"vector_pvacuum_double_T_insert(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::iterator pos, std::vector< std::pair< double,double > >::size_type n, pvacuum_double_T x)\n"
 		""},
-	 { "vector_pvacuum_double_t_reserve", _wrap_vector_pvacuum_double_t_reserve, METH_VARARGS, "vector_pvacuum_double_t_reserve(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::size_type n)"},
-	 { "vector_pvacuum_double_t_capacity", _wrap_vector_pvacuum_double_t_capacity, METH_O, "vector_pvacuum_double_t_capacity(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::size_type"},
-	 { "delete_vector_pvacuum_double_t", _wrap_delete_vector_pvacuum_double_t, METH_O, "delete_vector_pvacuum_double_t(vector_pvacuum_double_t self)"},
-	 { "vector_pvacuum_double_t_swigregister", vector_pvacuum_double_t_swigregister, METH_O, NULL},
-	 { "vector_pvacuum_double_t_swiginit", vector_pvacuum_double_t_swiginit, METH_VARARGS, NULL},
+	 { "vector_pvacuum_double_T_reserve", _wrap_vector_pvacuum_double_T_reserve, METH_VARARGS, "vector_pvacuum_double_T_reserve(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::size_type n)"},
+	 { "vector_pvacuum_double_T_capacity", _wrap_vector_pvacuum_double_T_capacity, METH_O, "vector_pvacuum_double_T_capacity(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::size_type"},
+	 { "delete_vector_pvacuum_double_T", _wrap_delete_vector_pvacuum_double_T, METH_O, "delete_vector_pvacuum_double_T(vector_pvacuum_double_T self)"},
+	 { "vector_pvacuum_double_T_swigregister", vector_pvacuum_double_T_swigregister, METH_O, NULL},
+	 { "vector_pvacuum_double_T_swiginit", vector_pvacuum_double_T_swiginit, METH_VARARGS, NULL},
 	 { "new_RealLimits", _wrap_new_RealLimits, METH_NOARGS, "new_RealLimits() -> RealLimits"},
 	 { "RealLimits_lowerLimited", _wrap_RealLimits_lowerLimited, METH_O, "RealLimits_lowerLimited(double bound_value) -> RealLimits"},
 	 { "RealLimits_positive", _wrap_RealLimits_positive, METH_NOARGS, "RealLimits_positive() -> RealLimits"},
@@ -30050,12 +30046,12 @@ static PyMethodDef SwigMethods[] = {
 		"Parameters_end(Parameters self) -> mumufit::Parameters::iterator\n"
 		""},
 	 { "Parameters_size", _wrap_Parameters_size, METH_O, "Parameters_size(Parameters self) -> size_t"},
-	 { "Parameters_values", _wrap_Parameters_values, METH_O, "Parameters_values(Parameters self) -> vdouble1d_t"},
-	 { "Parameters_setValues", _wrap_Parameters_setValues, METH_VARARGS, "Parameters_setValues(Parameters self, vdouble1d_t values)"},
-	 { "Parameters_errors", _wrap_Parameters_errors, METH_O, "Parameters_errors(Parameters self) -> vdouble1d_t"},
-	 { "Parameters_setErrors", _wrap_Parameters_setErrors, METH_VARARGS, "Parameters_setErrors(Parameters self, vdouble1d_t errors)"},
-	 { "Parameters_correlationMatrix", _wrap_Parameters_correlationMatrix, METH_O, "Parameters_correlationMatrix(Parameters self) -> vdouble2d_t"},
-	 { "Parameters_setCorrelationMatrix", _wrap_Parameters_setCorrelationMatrix, METH_VARARGS, "Parameters_setCorrelationMatrix(Parameters self, vdouble2d_t matrix)"},
+	 { "Parameters_values", _wrap_Parameters_values, METH_O, "Parameters_values(Parameters self) -> vdouble1d_T"},
+	 { "Parameters_setValues", _wrap_Parameters_setValues, METH_VARARGS, "Parameters_setValues(Parameters self, vdouble1d_T values)"},
+	 { "Parameters_errors", _wrap_Parameters_errors, METH_O, "Parameters_errors(Parameters self) -> vdouble1d_T"},
+	 { "Parameters_setErrors", _wrap_Parameters_setErrors, METH_VARARGS, "Parameters_setErrors(Parameters self, vdouble1d_T errors)"},
+	 { "Parameters_correlationMatrix", _wrap_Parameters_correlationMatrix, METH_O, "Parameters_correlationMatrix(Parameters self) -> double2d_t"},
+	 { "Parameters_setCorrelationMatrix", _wrap_Parameters_setCorrelationMatrix, METH_VARARGS, "Parameters_setCorrelationMatrix(Parameters self, double2d_t const & matrix)"},
 	 { "Parameters_freeParameterCount", _wrap_Parameters_freeParameterCount, METH_O, "Parameters_freeParameterCount(Parameters self) -> size_t"},
 	 { "Parameters___getitem__", _wrap_Parameters___getitem__, METH_VARARGS, "\n"
 		"Parameters___getitem__(Parameters self, std::string name) -> Parameter\n"
@@ -30099,8 +30095,8 @@ static PyMethodDef SwigMethods[] = {
 	 { "MinimizerFactory_printCatalog", _wrap_MinimizerFactory_printCatalog, METH_NOARGS, "MinimizerFactory_printCatalog()"},
 	 { "MinimizerFactory_catalogToString", _wrap_MinimizerFactory_catalogToString, METH_NOARGS, "MinimizerFactory_catalogToString() -> std::string"},
 	 { "MinimizerFactory_catalogDetailsToString", _wrap_MinimizerFactory_catalogDetailsToString, METH_NOARGS, "MinimizerFactory_catalogDetailsToString() -> std::string"},
-	 { "MinimizerFactory_algorithmNames", _wrap_MinimizerFactory_algorithmNames, METH_O, "MinimizerFactory_algorithmNames(std::string const & minimizerName) -> vector_string_t"},
-	 { "MinimizerFactory_algorithmDescriptions", _wrap_MinimizerFactory_algorithmDescriptions, METH_O, "MinimizerFactory_algorithmDescriptions(std::string const & minimizerName) -> vector_string_t"},
+	 { "MinimizerFactory_algorithmNames", _wrap_MinimizerFactory_algorithmNames, METH_O, "MinimizerFactory_algorithmNames(std::string const & minimizerName) -> vector_string_T"},
+	 { "MinimizerFactory_algorithmDescriptions", _wrap_MinimizerFactory_algorithmDescriptions, METH_O, "MinimizerFactory_algorithmDescriptions(std::string const & minimizerName) -> vector_string_T"},
 	 { "new_MinimizerFactory", _wrap_new_MinimizerFactory, METH_NOARGS, "new_MinimizerFactory() -> MinimizerFactory"},
 	 { "delete_MinimizerFactory", _wrap_delete_MinimizerFactory, METH_O, "delete_MinimizerFactory(MinimizerFactory self)"},
 	 { "MinimizerFactory_swigregister", MinimizerFactory_swigregister, METH_O, NULL},
@@ -30109,7 +30105,7 @@ static PyMethodDef SwigMethods[] = {
 	 { "delete_PyCallback", _wrap_delete_PyCallback, METH_O, "delete_PyCallback(PyCallback self)"},
 	 { "PyCallback_callback_type", _wrap_PyCallback_callback_type, METH_O, "PyCallback_callback_type(PyCallback self) -> PyCallback::CallbackType"},
 	 { "PyCallback_call_scalar", _wrap_PyCallback_call_scalar, METH_VARARGS, "PyCallback_call_scalar(PyCallback self, Parameters pars) -> double"},
-	 { "PyCallback_call_residuals", _wrap_PyCallback_call_residuals, METH_VARARGS, "PyCallback_call_residuals(PyCallback self, Parameters pars) -> vdouble1d_t"},
+	 { "PyCallback_call_residuals", _wrap_PyCallback_call_residuals, METH_VARARGS, "PyCallback_call_residuals(PyCallback self, Parameters pars) -> vdouble1d_T"},
 	 { "disown_PyCallback", _wrap_disown_PyCallback, METH_O, NULL},
 	 { "PyCallback_swigregister", PyCallback_swigregister, METH_O, NULL},
 	 { "PyCallback_swiginit", PyCallback_swiginit, METH_VARARGS, NULL},
@@ -30127,8 +30123,8 @@ static swig_type_info _swigt__p_RealLimits = {"_p_RealLimits", "RealLimits *", 0
 static swig_type_info _swigt__p_allocator_type = {"_p_allocator_type", "allocator_type *", 0, 0, (void*)0, 0};
 static swig_type_info _swigt__p_char = {"_p_char", "char *", 0, 0, (void*)0, 0};
 static swig_type_info _swigt__p_const_iterator = {"_p_const_iterator", "const_iterator *", 0, 0, (void*)0, 0};
-static swig_type_info _swigt__p_corr_matrix_t = {"_p_corr_matrix_t", "corr_matrix_t *", 0, 0, (void*)0, 0};
 static swig_type_info _swigt__p_difference_type = {"_p_difference_type", "difference_type *", 0, 0, (void*)0, 0};
+static swig_type_info _swigt__p_double2d_t = {"_p_double2d_t", "double2d_t *", 0, 0, (void*)0, 0};
 static swig_type_info _swigt__p_fcn_residual_t = {"_p_fcn_residual_t", "fcn_residual_t *", 0, 0, (void*)0, 0};
 static swig_type_info _swigt__p_fcn_scalar_t = {"_p_fcn_scalar_t", "fcn_scalar_t *", 0, 0, (void*)0, 0};
 static swig_type_info _swigt__p_first_type = {"_p_first_type", "first_type *", 0, 0, (void*)0, 0};
@@ -30186,8 +30182,8 @@ static swig_type_info *swig_type_initial[] = {
   &_swigt__p_allocator_type,
   &_swigt__p_char,
   &_swigt__p_const_iterator,
-  &_swigt__p_corr_matrix_t,
   &_swigt__p_difference_type,
+  &_swigt__p_double2d_t,
   &_swigt__p_fcn_residual_t,
   &_swigt__p_fcn_scalar_t,
   &_swigt__p_first_type,
@@ -30245,8 +30241,8 @@ static swig_cast_info _swigc__p_RealLimits[] = {  {&_swigt__p_RealLimits, 0, 0,
 static swig_cast_info _swigc__p_allocator_type[] = {  {&_swigt__p_allocator_type, 0, 0, 0},{0, 0, 0, 0}};
 static swig_cast_info _swigc__p_char[] = {  {&_swigt__p_char, 0, 0, 0},{0, 0, 0, 0}};
 static swig_cast_info _swigc__p_const_iterator[] = {  {&_swigt__p_const_iterator, 0, 0, 0},{0, 0, 0, 0}};
-static swig_cast_info _swigc__p_corr_matrix_t[] = {  {&_swigt__p_corr_matrix_t, 0, 0, 0},{0, 0, 0, 0}};
 static swig_cast_info _swigc__p_difference_type[] = {  {&_swigt__p_difference_type, 0, 0, 0},{0, 0, 0, 0}};
+static swig_cast_info _swigc__p_double2d_t[] = {  {&_swigt__p_double2d_t, 0, 0, 0},{0, 0, 0, 0}};
 static swig_cast_info _swigc__p_fcn_residual_t[] = {  {&_swigt__p_fcn_residual_t, 0, 0, 0},{0, 0, 0, 0}};
 static swig_cast_info _swigc__p_fcn_scalar_t[] = {  {&_swigt__p_fcn_scalar_t, 0, 0, 0},{0, 0, 0, 0}};
 static swig_cast_info _swigc__p_first_type[] = {  {&_swigt__p_first_type, 0, 0, 0},{0, 0, 0, 0}};
@@ -30304,8 +30300,8 @@ static swig_cast_info *swig_cast_initial[] = {
   _swigc__p_allocator_type,
   _swigc__p_char,
   _swigc__p_const_iterator,
-  _swigc__p_corr_matrix_t,
   _swigc__p_difference_type,
+  _swigc__p_double2d_t,
   _swigc__p_fcn_residual_t,
   _swigc__p_fcn_scalar_t,
   _swigc__p_first_type,
diff --git a/auto/Wrap/libBornAgainParam.py b/auto/Wrap/libBornAgainParam.py
index 790720bbedbac6d70c3fd207465ffcb575854d22..24a867d7b28aeba10c86e5d3cbc6dc981e61243d 100644
--- a/auto/Wrap/libBornAgainParam.py
+++ b/auto/Wrap/libBornAgainParam.py
@@ -153,1191 +153,1191 @@ def deprecated(message):
       return deprecated_func
   return deprecated_decorator
 
-class vdouble1d_t(object):
+class vdouble1d_T(object):
     r"""Proxy of C++ std::vector< double > class."""
 
     thisown = property(lambda x: x.this.own(), lambda x, v: x.this.own(v), doc="The membership flag")
     __repr__ = _swig_repr
 
     def iterator(self):
-        r"""iterator(vdouble1d_t self) -> SwigPyIterator"""
-        return _libBornAgainParam.vdouble1d_t_iterator(self)
+        r"""iterator(vdouble1d_T self) -> SwigPyIterator"""
+        return _libBornAgainParam.vdouble1d_T_iterator(self)
     def __iter__(self):
         return self.iterator()
 
     def __nonzero__(self):
-        r"""__nonzero__(vdouble1d_t self) -> bool"""
-        return _libBornAgainParam.vdouble1d_t___nonzero__(self)
+        r"""__nonzero__(vdouble1d_T self) -> bool"""
+        return _libBornAgainParam.vdouble1d_T___nonzero__(self)
 
     def __bool__(self):
-        r"""__bool__(vdouble1d_t self) -> bool"""
-        return _libBornAgainParam.vdouble1d_t___bool__(self)
+        r"""__bool__(vdouble1d_T self) -> bool"""
+        return _libBornAgainParam.vdouble1d_T___bool__(self)
 
     def __len__(self):
-        r"""__len__(vdouble1d_t self) -> std::vector< double >::size_type"""
-        return _libBornAgainParam.vdouble1d_t___len__(self)
+        r"""__len__(vdouble1d_T self) -> std::vector< double >::size_type"""
+        return _libBornAgainParam.vdouble1d_T___len__(self)
 
     def __getslice__(self, i, j):
-        r"""__getslice__(vdouble1d_t self, std::vector< double >::difference_type i, std::vector< double >::difference_type j) -> vdouble1d_t"""
-        return _libBornAgainParam.vdouble1d_t___getslice__(self, i, j)
+        r"""__getslice__(vdouble1d_T self, std::vector< double >::difference_type i, std::vector< double >::difference_type j) -> vdouble1d_T"""
+        return _libBornAgainParam.vdouble1d_T___getslice__(self, i, j)
 
     def __setslice__(self, *args):
         r"""
-        __setslice__(vdouble1d_t self, std::vector< double >::difference_type i, std::vector< double >::difference_type j)
-        __setslice__(vdouble1d_t self, std::vector< double >::difference_type i, std::vector< double >::difference_type j, vdouble1d_t v)
+        __setslice__(vdouble1d_T self, std::vector< double >::difference_type i, std::vector< double >::difference_type j)
+        __setslice__(vdouble1d_T self, std::vector< double >::difference_type i, std::vector< double >::difference_type j, vdouble1d_T v)
         """
-        return _libBornAgainParam.vdouble1d_t___setslice__(self, *args)
+        return _libBornAgainParam.vdouble1d_T___setslice__(self, *args)
 
     def __delslice__(self, i, j):
-        r"""__delslice__(vdouble1d_t self, std::vector< double >::difference_type i, std::vector< double >::difference_type j)"""
-        return _libBornAgainParam.vdouble1d_t___delslice__(self, i, j)
+        r"""__delslice__(vdouble1d_T self, std::vector< double >::difference_type i, std::vector< double >::difference_type j)"""
+        return _libBornAgainParam.vdouble1d_T___delslice__(self, i, j)
 
     def __delitem__(self, *args):
         r"""
-        __delitem__(vdouble1d_t self, std::vector< double >::difference_type i)
-        __delitem__(vdouble1d_t self, SWIGPY_SLICEOBJECT * slice)
+        __delitem__(vdouble1d_T self, std::vector< double >::difference_type i)
+        __delitem__(vdouble1d_T self, SWIGPY_SLICEOBJECT * slice)
         """
-        return _libBornAgainParam.vdouble1d_t___delitem__(self, *args)
+        return _libBornAgainParam.vdouble1d_T___delitem__(self, *args)
 
     def __getitem__(self, *args):
         r"""
-        __getitem__(vdouble1d_t self, SWIGPY_SLICEOBJECT * slice) -> vdouble1d_t
-        __getitem__(vdouble1d_t self, std::vector< double >::difference_type i) -> std::vector< double >::value_type const &
+        __getitem__(vdouble1d_T self, SWIGPY_SLICEOBJECT * slice) -> vdouble1d_T
+        __getitem__(vdouble1d_T self, std::vector< double >::difference_type i) -> std::vector< double >::value_type const &
         """
-        return _libBornAgainParam.vdouble1d_t___getitem__(self, *args)
+        return _libBornAgainParam.vdouble1d_T___getitem__(self, *args)
 
     def __setitem__(self, *args):
         r"""
-        __setitem__(vdouble1d_t self, SWIGPY_SLICEOBJECT * slice, vdouble1d_t v)
-        __setitem__(vdouble1d_t self, SWIGPY_SLICEOBJECT * slice)
-        __setitem__(vdouble1d_t self, std::vector< double >::difference_type i, std::vector< double >::value_type const & x)
+        __setitem__(vdouble1d_T self, SWIGPY_SLICEOBJECT * slice, vdouble1d_T v)
+        __setitem__(vdouble1d_T self, SWIGPY_SLICEOBJECT * slice)
+        __setitem__(vdouble1d_T self, std::vector< double >::difference_type i, std::vector< double >::value_type const & x)
         """
-        return _libBornAgainParam.vdouble1d_t___setitem__(self, *args)
+        return _libBornAgainParam.vdouble1d_T___setitem__(self, *args)
 
     def pop(self):
-        r"""pop(vdouble1d_t self) -> std::vector< double >::value_type"""
-        return _libBornAgainParam.vdouble1d_t_pop(self)
+        r"""pop(vdouble1d_T self) -> std::vector< double >::value_type"""
+        return _libBornAgainParam.vdouble1d_T_pop(self)
 
     def append(self, x):
-        r"""append(vdouble1d_t self, std::vector< double >::value_type const & x)"""
-        return _libBornAgainParam.vdouble1d_t_append(self, x)
+        r"""append(vdouble1d_T self, std::vector< double >::value_type const & x)"""
+        return _libBornAgainParam.vdouble1d_T_append(self, x)
 
     def empty(self):
-        r"""empty(vdouble1d_t self) -> bool"""
-        return _libBornAgainParam.vdouble1d_t_empty(self)
+        r"""empty(vdouble1d_T self) -> bool"""
+        return _libBornAgainParam.vdouble1d_T_empty(self)
 
     def size(self):
-        r"""size(vdouble1d_t self) -> std::vector< double >::size_type"""
-        return _libBornAgainParam.vdouble1d_t_size(self)
+        r"""size(vdouble1d_T self) -> std::vector< double >::size_type"""
+        return _libBornAgainParam.vdouble1d_T_size(self)
 
     def swap(self, v):
-        r"""swap(vdouble1d_t self, vdouble1d_t v)"""
-        return _libBornAgainParam.vdouble1d_t_swap(self, v)
+        r"""swap(vdouble1d_T self, vdouble1d_T v)"""
+        return _libBornAgainParam.vdouble1d_T_swap(self, v)
 
     def begin(self):
-        r"""begin(vdouble1d_t self) -> std::vector< double >::iterator"""
-        return _libBornAgainParam.vdouble1d_t_begin(self)
+        r"""begin(vdouble1d_T self) -> std::vector< double >::iterator"""
+        return _libBornAgainParam.vdouble1d_T_begin(self)
 
     def end(self):
-        r"""end(vdouble1d_t self) -> std::vector< double >::iterator"""
-        return _libBornAgainParam.vdouble1d_t_end(self)
+        r"""end(vdouble1d_T self) -> std::vector< double >::iterator"""
+        return _libBornAgainParam.vdouble1d_T_end(self)
 
     def rbegin(self):
-        r"""rbegin(vdouble1d_t self) -> std::vector< double >::reverse_iterator"""
-        return _libBornAgainParam.vdouble1d_t_rbegin(self)
+        r"""rbegin(vdouble1d_T self) -> std::vector< double >::reverse_iterator"""
+        return _libBornAgainParam.vdouble1d_T_rbegin(self)
 
     def rend(self):
-        r"""rend(vdouble1d_t self) -> std::vector< double >::reverse_iterator"""
-        return _libBornAgainParam.vdouble1d_t_rend(self)
+        r"""rend(vdouble1d_T self) -> std::vector< double >::reverse_iterator"""
+        return _libBornAgainParam.vdouble1d_T_rend(self)
 
     def clear(self):
-        r"""clear(vdouble1d_t self)"""
-        return _libBornAgainParam.vdouble1d_t_clear(self)
+        r"""clear(vdouble1d_T self)"""
+        return _libBornAgainParam.vdouble1d_T_clear(self)
 
     def get_allocator(self):
-        r"""get_allocator(vdouble1d_t self) -> std::vector< double >::allocator_type"""
-        return _libBornAgainParam.vdouble1d_t_get_allocator(self)
+        r"""get_allocator(vdouble1d_T self) -> std::vector< double >::allocator_type"""
+        return _libBornAgainParam.vdouble1d_T_get_allocator(self)
 
     def pop_back(self):
-        r"""pop_back(vdouble1d_t self)"""
-        return _libBornAgainParam.vdouble1d_t_pop_back(self)
+        r"""pop_back(vdouble1d_T self)"""
+        return _libBornAgainParam.vdouble1d_T_pop_back(self)
 
     def erase(self, *args):
         r"""
-        erase(vdouble1d_t self, std::vector< double >::iterator pos) -> std::vector< double >::iterator
-        erase(vdouble1d_t self, std::vector< double >::iterator first, std::vector< double >::iterator last) -> std::vector< double >::iterator
+        erase(vdouble1d_T self, std::vector< double >::iterator pos) -> std::vector< double >::iterator
+        erase(vdouble1d_T self, std::vector< double >::iterator first, std::vector< double >::iterator last) -> std::vector< double >::iterator
         """
-        return _libBornAgainParam.vdouble1d_t_erase(self, *args)
+        return _libBornAgainParam.vdouble1d_T_erase(self, *args)
 
     def __init__(self, *args):
         r"""
-        __init__(vdouble1d_t self) -> vdouble1d_t
-        __init__(vdouble1d_t self, vdouble1d_t other) -> vdouble1d_t
-        __init__(vdouble1d_t self, std::vector< double >::size_type size) -> vdouble1d_t
-        __init__(vdouble1d_t self, std::vector< double >::size_type size, std::vector< double >::value_type const & value) -> vdouble1d_t
+        __init__(vdouble1d_T self) -> vdouble1d_T
+        __init__(vdouble1d_T self, vdouble1d_T other) -> vdouble1d_T
+        __init__(vdouble1d_T self, std::vector< double >::size_type size) -> vdouble1d_T
+        __init__(vdouble1d_T self, std::vector< double >::size_type size, std::vector< double >::value_type const & value) -> vdouble1d_T
         """
-        _libBornAgainParam.vdouble1d_t_swiginit(self, _libBornAgainParam.new_vdouble1d_t(*args))
+        _libBornAgainParam.vdouble1d_T_swiginit(self, _libBornAgainParam.new_vdouble1d_T(*args))
 
     def push_back(self, x):
-        r"""push_back(vdouble1d_t self, std::vector< double >::value_type const & x)"""
-        return _libBornAgainParam.vdouble1d_t_push_back(self, x)
+        r"""push_back(vdouble1d_T self, std::vector< double >::value_type const & x)"""
+        return _libBornAgainParam.vdouble1d_T_push_back(self, x)
 
     def front(self):
-        r"""front(vdouble1d_t self) -> std::vector< double >::value_type const &"""
-        return _libBornAgainParam.vdouble1d_t_front(self)
+        r"""front(vdouble1d_T self) -> std::vector< double >::value_type const &"""
+        return _libBornAgainParam.vdouble1d_T_front(self)
 
     def back(self):
-        r"""back(vdouble1d_t self) -> std::vector< double >::value_type const &"""
-        return _libBornAgainParam.vdouble1d_t_back(self)
+        r"""back(vdouble1d_T self) -> std::vector< double >::value_type const &"""
+        return _libBornAgainParam.vdouble1d_T_back(self)
 
     def assign(self, n, x):
-        r"""assign(vdouble1d_t self, std::vector< double >::size_type n, std::vector< double >::value_type const & x)"""
-        return _libBornAgainParam.vdouble1d_t_assign(self, n, x)
+        r"""assign(vdouble1d_T self, std::vector< double >::size_type n, std::vector< double >::value_type const & x)"""
+        return _libBornAgainParam.vdouble1d_T_assign(self, n, x)
 
     def resize(self, *args):
         r"""
-        resize(vdouble1d_t self, std::vector< double >::size_type new_size)
-        resize(vdouble1d_t self, std::vector< double >::size_type new_size, std::vector< double >::value_type const & x)
+        resize(vdouble1d_T self, std::vector< double >::size_type new_size)
+        resize(vdouble1d_T self, std::vector< double >::size_type new_size, std::vector< double >::value_type const & x)
         """
-        return _libBornAgainParam.vdouble1d_t_resize(self, *args)
+        return _libBornAgainParam.vdouble1d_T_resize(self, *args)
 
     def insert(self, *args):
         r"""
-        insert(vdouble1d_t self, std::vector< double >::iterator pos, std::vector< double >::value_type const & x) -> std::vector< double >::iterator
-        insert(vdouble1d_t self, std::vector< double >::iterator pos, std::vector< double >::size_type n, std::vector< double >::value_type const & x)
+        insert(vdouble1d_T self, std::vector< double >::iterator pos, std::vector< double >::value_type const & x) -> std::vector< double >::iterator
+        insert(vdouble1d_T self, std::vector< double >::iterator pos, std::vector< double >::size_type n, std::vector< double >::value_type const & x)
         """
-        return _libBornAgainParam.vdouble1d_t_insert(self, *args)
+        return _libBornAgainParam.vdouble1d_T_insert(self, *args)
 
     def reserve(self, n):
-        r"""reserve(vdouble1d_t self, std::vector< double >::size_type n)"""
-        return _libBornAgainParam.vdouble1d_t_reserve(self, n)
+        r"""reserve(vdouble1d_T self, std::vector< double >::size_type n)"""
+        return _libBornAgainParam.vdouble1d_T_reserve(self, n)
 
     def capacity(self):
-        r"""capacity(vdouble1d_t self) -> std::vector< double >::size_type"""
-        return _libBornAgainParam.vdouble1d_t_capacity(self)
-    __swig_destroy__ = _libBornAgainParam.delete_vdouble1d_t
+        r"""capacity(vdouble1d_T self) -> std::vector< double >::size_type"""
+        return _libBornAgainParam.vdouble1d_T_capacity(self)
+    __swig_destroy__ = _libBornAgainParam.delete_vdouble1d_T
 
-# Register vdouble1d_t in _libBornAgainParam:
-_libBornAgainParam.vdouble1d_t_swigregister(vdouble1d_t)
-class vdouble2d_t(object):
+# Register vdouble1d_T in _libBornAgainParam:
+_libBornAgainParam.vdouble1d_T_swigregister(vdouble1d_T)
+class vdouble2d_T(object):
     r"""Proxy of C++ std::vector< std::vector< double > > class."""
 
     thisown = property(lambda x: x.this.own(), lambda x, v: x.this.own(v), doc="The membership flag")
     __repr__ = _swig_repr
 
     def iterator(self):
-        r"""iterator(vdouble2d_t self) -> SwigPyIterator"""
-        return _libBornAgainParam.vdouble2d_t_iterator(self)
+        r"""iterator(vdouble2d_T self) -> SwigPyIterator"""
+        return _libBornAgainParam.vdouble2d_T_iterator(self)
     def __iter__(self):
         return self.iterator()
 
     def __nonzero__(self):
-        r"""__nonzero__(vdouble2d_t self) -> bool"""
-        return _libBornAgainParam.vdouble2d_t___nonzero__(self)
+        r"""__nonzero__(vdouble2d_T self) -> bool"""
+        return _libBornAgainParam.vdouble2d_T___nonzero__(self)
 
     def __bool__(self):
-        r"""__bool__(vdouble2d_t self) -> bool"""
-        return _libBornAgainParam.vdouble2d_t___bool__(self)
+        r"""__bool__(vdouble2d_T self) -> bool"""
+        return _libBornAgainParam.vdouble2d_T___bool__(self)
 
     def __len__(self):
-        r"""__len__(vdouble2d_t self) -> std::vector< std::vector< double > >::size_type"""
-        return _libBornAgainParam.vdouble2d_t___len__(self)
+        r"""__len__(vdouble2d_T self) -> std::vector< std::vector< double > >::size_type"""
+        return _libBornAgainParam.vdouble2d_T___len__(self)
 
     def __getslice__(self, i, j):
-        r"""__getslice__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j) -> vdouble2d_t"""
-        return _libBornAgainParam.vdouble2d_t___getslice__(self, i, j)
+        r"""__getslice__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j) -> vdouble2d_T"""
+        return _libBornAgainParam.vdouble2d_T___getslice__(self, i, j)
 
     def __setslice__(self, *args):
         r"""
-        __setslice__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j)
-        __setslice__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j, vdouble2d_t v)
+        __setslice__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j)
+        __setslice__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j, vdouble2d_T v)
         """
-        return _libBornAgainParam.vdouble2d_t___setslice__(self, *args)
+        return _libBornAgainParam.vdouble2d_T___setslice__(self, *args)
 
     def __delslice__(self, i, j):
-        r"""__delslice__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j)"""
-        return _libBornAgainParam.vdouble2d_t___delslice__(self, i, j)
+        r"""__delslice__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j)"""
+        return _libBornAgainParam.vdouble2d_T___delslice__(self, i, j)
 
     def __delitem__(self, *args):
         r"""
-        __delitem__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i)
-        __delitem__(vdouble2d_t self, SWIGPY_SLICEOBJECT * slice)
+        __delitem__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i)
+        __delitem__(vdouble2d_T self, SWIGPY_SLICEOBJECT * slice)
         """
-        return _libBornAgainParam.vdouble2d_t___delitem__(self, *args)
+        return _libBornAgainParam.vdouble2d_T___delitem__(self, *args)
 
     def __getitem__(self, *args):
         r"""
-        __getitem__(vdouble2d_t self, SWIGPY_SLICEOBJECT * slice) -> vdouble2d_t
-        __getitem__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i) -> vdouble1d_t
+        __getitem__(vdouble2d_T self, SWIGPY_SLICEOBJECT * slice) -> vdouble2d_T
+        __getitem__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i) -> vdouble1d_T
         """
-        return _libBornAgainParam.vdouble2d_t___getitem__(self, *args)
+        return _libBornAgainParam.vdouble2d_T___getitem__(self, *args)
 
     def __setitem__(self, *args):
         r"""
-        __setitem__(vdouble2d_t self, SWIGPY_SLICEOBJECT * slice, vdouble2d_t v)
-        __setitem__(vdouble2d_t self, SWIGPY_SLICEOBJECT * slice)
-        __setitem__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i, vdouble1d_t x)
+        __setitem__(vdouble2d_T self, SWIGPY_SLICEOBJECT * slice, vdouble2d_T v)
+        __setitem__(vdouble2d_T self, SWIGPY_SLICEOBJECT * slice)
+        __setitem__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i, vdouble1d_T x)
         """
-        return _libBornAgainParam.vdouble2d_t___setitem__(self, *args)
+        return _libBornAgainParam.vdouble2d_T___setitem__(self, *args)
 
     def pop(self):
-        r"""pop(vdouble2d_t self) -> vdouble1d_t"""
-        return _libBornAgainParam.vdouble2d_t_pop(self)
+        r"""pop(vdouble2d_T self) -> vdouble1d_T"""
+        return _libBornAgainParam.vdouble2d_T_pop(self)
 
     def append(self, x):
-        r"""append(vdouble2d_t self, vdouble1d_t x)"""
-        return _libBornAgainParam.vdouble2d_t_append(self, x)
+        r"""append(vdouble2d_T self, vdouble1d_T x)"""
+        return _libBornAgainParam.vdouble2d_T_append(self, x)
 
     def empty(self):
-        r"""empty(vdouble2d_t self) -> bool"""
-        return _libBornAgainParam.vdouble2d_t_empty(self)
+        r"""empty(vdouble2d_T self) -> bool"""
+        return _libBornAgainParam.vdouble2d_T_empty(self)
 
     def size(self):
-        r"""size(vdouble2d_t self) -> std::vector< std::vector< double > >::size_type"""
-        return _libBornAgainParam.vdouble2d_t_size(self)
+        r"""size(vdouble2d_T self) -> std::vector< std::vector< double > >::size_type"""
+        return _libBornAgainParam.vdouble2d_T_size(self)
 
     def swap(self, v):
-        r"""swap(vdouble2d_t self, vdouble2d_t v)"""
-        return _libBornAgainParam.vdouble2d_t_swap(self, v)
+        r"""swap(vdouble2d_T self, vdouble2d_T v)"""
+        return _libBornAgainParam.vdouble2d_T_swap(self, v)
 
     def begin(self):
-        r"""begin(vdouble2d_t self) -> std::vector< std::vector< double > >::iterator"""
-        return _libBornAgainParam.vdouble2d_t_begin(self)
+        r"""begin(vdouble2d_T self) -> std::vector< std::vector< double > >::iterator"""
+        return _libBornAgainParam.vdouble2d_T_begin(self)
 
     def end(self):
-        r"""end(vdouble2d_t self) -> std::vector< std::vector< double > >::iterator"""
-        return _libBornAgainParam.vdouble2d_t_end(self)
+        r"""end(vdouble2d_T self) -> std::vector< std::vector< double > >::iterator"""
+        return _libBornAgainParam.vdouble2d_T_end(self)
 
     def rbegin(self):
-        r"""rbegin(vdouble2d_t self) -> std::vector< std::vector< double > >::reverse_iterator"""
-        return _libBornAgainParam.vdouble2d_t_rbegin(self)
+        r"""rbegin(vdouble2d_T self) -> std::vector< std::vector< double > >::reverse_iterator"""
+        return _libBornAgainParam.vdouble2d_T_rbegin(self)
 
     def rend(self):
-        r"""rend(vdouble2d_t self) -> std::vector< std::vector< double > >::reverse_iterator"""
-        return _libBornAgainParam.vdouble2d_t_rend(self)
+        r"""rend(vdouble2d_T self) -> std::vector< std::vector< double > >::reverse_iterator"""
+        return _libBornAgainParam.vdouble2d_T_rend(self)
 
     def clear(self):
-        r"""clear(vdouble2d_t self)"""
-        return _libBornAgainParam.vdouble2d_t_clear(self)
+        r"""clear(vdouble2d_T self)"""
+        return _libBornAgainParam.vdouble2d_T_clear(self)
 
     def get_allocator(self):
-        r"""get_allocator(vdouble2d_t self) -> std::vector< std::vector< double > >::allocator_type"""
-        return _libBornAgainParam.vdouble2d_t_get_allocator(self)
+        r"""get_allocator(vdouble2d_T self) -> std::vector< std::vector< double > >::allocator_type"""
+        return _libBornAgainParam.vdouble2d_T_get_allocator(self)
 
     def pop_back(self):
-        r"""pop_back(vdouble2d_t self)"""
-        return _libBornAgainParam.vdouble2d_t_pop_back(self)
+        r"""pop_back(vdouble2d_T self)"""
+        return _libBornAgainParam.vdouble2d_T_pop_back(self)
 
     def erase(self, *args):
         r"""
-        erase(vdouble2d_t self, std::vector< std::vector< double > >::iterator pos) -> std::vector< std::vector< double > >::iterator
-        erase(vdouble2d_t self, std::vector< std::vector< double > >::iterator first, std::vector< std::vector< double > >::iterator last) -> std::vector< std::vector< double > >::iterator
+        erase(vdouble2d_T self, std::vector< std::vector< double > >::iterator pos) -> std::vector< std::vector< double > >::iterator
+        erase(vdouble2d_T self, std::vector< std::vector< double > >::iterator first, std::vector< std::vector< double > >::iterator last) -> std::vector< std::vector< double > >::iterator
         """
-        return _libBornAgainParam.vdouble2d_t_erase(self, *args)
+        return _libBornAgainParam.vdouble2d_T_erase(self, *args)
 
     def __init__(self, *args):
         r"""
-        __init__(vdouble2d_t self) -> vdouble2d_t
-        __init__(vdouble2d_t self, vdouble2d_t other) -> vdouble2d_t
-        __init__(vdouble2d_t self, std::vector< std::vector< double > >::size_type size) -> vdouble2d_t
-        __init__(vdouble2d_t self, std::vector< std::vector< double > >::size_type size, vdouble1d_t value) -> vdouble2d_t
+        __init__(vdouble2d_T self) -> vdouble2d_T
+        __init__(vdouble2d_T self, vdouble2d_T other) -> vdouble2d_T
+        __init__(vdouble2d_T self, std::vector< std::vector< double > >::size_type size) -> vdouble2d_T
+        __init__(vdouble2d_T self, std::vector< std::vector< double > >::size_type size, vdouble1d_T value) -> vdouble2d_T
         """
-        _libBornAgainParam.vdouble2d_t_swiginit(self, _libBornAgainParam.new_vdouble2d_t(*args))
+        _libBornAgainParam.vdouble2d_T_swiginit(self, _libBornAgainParam.new_vdouble2d_T(*args))
 
     def push_back(self, x):
-        r"""push_back(vdouble2d_t self, vdouble1d_t x)"""
-        return _libBornAgainParam.vdouble2d_t_push_back(self, x)
+        r"""push_back(vdouble2d_T self, vdouble1d_T x)"""
+        return _libBornAgainParam.vdouble2d_T_push_back(self, x)
 
     def front(self):
-        r"""front(vdouble2d_t self) -> vdouble1d_t"""
-        return _libBornAgainParam.vdouble2d_t_front(self)
+        r"""front(vdouble2d_T self) -> vdouble1d_T"""
+        return _libBornAgainParam.vdouble2d_T_front(self)
 
     def back(self):
-        r"""back(vdouble2d_t self) -> vdouble1d_t"""
-        return _libBornAgainParam.vdouble2d_t_back(self)
+        r"""back(vdouble2d_T self) -> vdouble1d_T"""
+        return _libBornAgainParam.vdouble2d_T_back(self)
 
     def assign(self, n, x):
-        r"""assign(vdouble2d_t self, std::vector< std::vector< double > >::size_type n, vdouble1d_t x)"""
-        return _libBornAgainParam.vdouble2d_t_assign(self, n, x)
+        r"""assign(vdouble2d_T self, std::vector< std::vector< double > >::size_type n, vdouble1d_T x)"""
+        return _libBornAgainParam.vdouble2d_T_assign(self, n, x)
 
     def resize(self, *args):
         r"""
-        resize(vdouble2d_t self, std::vector< std::vector< double > >::size_type new_size)
-        resize(vdouble2d_t self, std::vector< std::vector< double > >::size_type new_size, vdouble1d_t x)
+        resize(vdouble2d_T self, std::vector< std::vector< double > >::size_type new_size)
+        resize(vdouble2d_T self, std::vector< std::vector< double > >::size_type new_size, vdouble1d_T x)
         """
-        return _libBornAgainParam.vdouble2d_t_resize(self, *args)
+        return _libBornAgainParam.vdouble2d_T_resize(self, *args)
 
     def insert(self, *args):
         r"""
-        insert(vdouble2d_t self, std::vector< std::vector< double > >::iterator pos, vdouble1d_t x) -> std::vector< std::vector< double > >::iterator
-        insert(vdouble2d_t self, std::vector< std::vector< double > >::iterator pos, std::vector< std::vector< double > >::size_type n, vdouble1d_t x)
+        insert(vdouble2d_T self, std::vector< std::vector< double > >::iterator pos, vdouble1d_T x) -> std::vector< std::vector< double > >::iterator
+        insert(vdouble2d_T self, std::vector< std::vector< double > >::iterator pos, std::vector< std::vector< double > >::size_type n, vdouble1d_T x)
         """
-        return _libBornAgainParam.vdouble2d_t_insert(self, *args)
+        return _libBornAgainParam.vdouble2d_T_insert(self, *args)
 
     def reserve(self, n):
-        r"""reserve(vdouble2d_t self, std::vector< std::vector< double > >::size_type n)"""
-        return _libBornAgainParam.vdouble2d_t_reserve(self, n)
+        r"""reserve(vdouble2d_T self, std::vector< std::vector< double > >::size_type n)"""
+        return _libBornAgainParam.vdouble2d_T_reserve(self, n)
 
     def capacity(self):
-        r"""capacity(vdouble2d_t self) -> std::vector< std::vector< double > >::size_type"""
-        return _libBornAgainParam.vdouble2d_t_capacity(self)
-    __swig_destroy__ = _libBornAgainParam.delete_vdouble2d_t
+        r"""capacity(vdouble2d_T self) -> std::vector< std::vector< double > >::size_type"""
+        return _libBornAgainParam.vdouble2d_T_capacity(self)
+    __swig_destroy__ = _libBornAgainParam.delete_vdouble2d_T
 
-# Register vdouble2d_t in _libBornAgainParam:
-_libBornAgainParam.vdouble2d_t_swigregister(vdouble2d_t)
-class vector_integer_t(object):
+# Register vdouble2d_T in _libBornAgainParam:
+_libBornAgainParam.vdouble2d_T_swigregister(vdouble2d_T)
+class vector_integer_T(object):
     r"""Proxy of C++ std::vector< int > class."""
 
     thisown = property(lambda x: x.this.own(), lambda x, v: x.this.own(v), doc="The membership flag")
     __repr__ = _swig_repr
 
     def iterator(self):
-        r"""iterator(vector_integer_t self) -> SwigPyIterator"""
-        return _libBornAgainParam.vector_integer_t_iterator(self)
+        r"""iterator(vector_integer_T self) -> SwigPyIterator"""
+        return _libBornAgainParam.vector_integer_T_iterator(self)
     def __iter__(self):
         return self.iterator()
 
     def __nonzero__(self):
-        r"""__nonzero__(vector_integer_t self) -> bool"""
-        return _libBornAgainParam.vector_integer_t___nonzero__(self)
+        r"""__nonzero__(vector_integer_T self) -> bool"""
+        return _libBornAgainParam.vector_integer_T___nonzero__(self)
 
     def __bool__(self):
-        r"""__bool__(vector_integer_t self) -> bool"""
-        return _libBornAgainParam.vector_integer_t___bool__(self)
+        r"""__bool__(vector_integer_T self) -> bool"""
+        return _libBornAgainParam.vector_integer_T___bool__(self)
 
     def __len__(self):
-        r"""__len__(vector_integer_t self) -> std::vector< int >::size_type"""
-        return _libBornAgainParam.vector_integer_t___len__(self)
+        r"""__len__(vector_integer_T self) -> std::vector< int >::size_type"""
+        return _libBornAgainParam.vector_integer_T___len__(self)
 
     def __getslice__(self, i, j):
-        r"""__getslice__(vector_integer_t self, std::vector< int >::difference_type i, std::vector< int >::difference_type j) -> vector_integer_t"""
-        return _libBornAgainParam.vector_integer_t___getslice__(self, i, j)
+        r"""__getslice__(vector_integer_T self, std::vector< int >::difference_type i, std::vector< int >::difference_type j) -> vector_integer_T"""
+        return _libBornAgainParam.vector_integer_T___getslice__(self, i, j)
 
     def __setslice__(self, *args):
         r"""
-        __setslice__(vector_integer_t self, std::vector< int >::difference_type i, std::vector< int >::difference_type j)
-        __setslice__(vector_integer_t self, std::vector< int >::difference_type i, std::vector< int >::difference_type j, vector_integer_t v)
+        __setslice__(vector_integer_T self, std::vector< int >::difference_type i, std::vector< int >::difference_type j)
+        __setslice__(vector_integer_T self, std::vector< int >::difference_type i, std::vector< int >::difference_type j, vector_integer_T v)
         """
-        return _libBornAgainParam.vector_integer_t___setslice__(self, *args)
+        return _libBornAgainParam.vector_integer_T___setslice__(self, *args)
 
     def __delslice__(self, i, j):
-        r"""__delslice__(vector_integer_t self, std::vector< int >::difference_type i, std::vector< int >::difference_type j)"""
-        return _libBornAgainParam.vector_integer_t___delslice__(self, i, j)
+        r"""__delslice__(vector_integer_T self, std::vector< int >::difference_type i, std::vector< int >::difference_type j)"""
+        return _libBornAgainParam.vector_integer_T___delslice__(self, i, j)
 
     def __delitem__(self, *args):
         r"""
-        __delitem__(vector_integer_t self, std::vector< int >::difference_type i)
-        __delitem__(vector_integer_t self, SWIGPY_SLICEOBJECT * slice)
+        __delitem__(vector_integer_T self, std::vector< int >::difference_type i)
+        __delitem__(vector_integer_T self, SWIGPY_SLICEOBJECT * slice)
         """
-        return _libBornAgainParam.vector_integer_t___delitem__(self, *args)
+        return _libBornAgainParam.vector_integer_T___delitem__(self, *args)
 
     def __getitem__(self, *args):
         r"""
-        __getitem__(vector_integer_t self, SWIGPY_SLICEOBJECT * slice) -> vector_integer_t
-        __getitem__(vector_integer_t self, std::vector< int >::difference_type i) -> std::vector< int >::value_type const &
+        __getitem__(vector_integer_T self, SWIGPY_SLICEOBJECT * slice) -> vector_integer_T
+        __getitem__(vector_integer_T self, std::vector< int >::difference_type i) -> std::vector< int >::value_type const &
         """
-        return _libBornAgainParam.vector_integer_t___getitem__(self, *args)
+        return _libBornAgainParam.vector_integer_T___getitem__(self, *args)
 
     def __setitem__(self, *args):
         r"""
-        __setitem__(vector_integer_t self, SWIGPY_SLICEOBJECT * slice, vector_integer_t v)
-        __setitem__(vector_integer_t self, SWIGPY_SLICEOBJECT * slice)
-        __setitem__(vector_integer_t self, std::vector< int >::difference_type i, std::vector< int >::value_type const & x)
+        __setitem__(vector_integer_T self, SWIGPY_SLICEOBJECT * slice, vector_integer_T v)
+        __setitem__(vector_integer_T self, SWIGPY_SLICEOBJECT * slice)
+        __setitem__(vector_integer_T self, std::vector< int >::difference_type i, std::vector< int >::value_type const & x)
         """
-        return _libBornAgainParam.vector_integer_t___setitem__(self, *args)
+        return _libBornAgainParam.vector_integer_T___setitem__(self, *args)
 
     def pop(self):
-        r"""pop(vector_integer_t self) -> std::vector< int >::value_type"""
-        return _libBornAgainParam.vector_integer_t_pop(self)
+        r"""pop(vector_integer_T self) -> std::vector< int >::value_type"""
+        return _libBornAgainParam.vector_integer_T_pop(self)
 
     def append(self, x):
-        r"""append(vector_integer_t self, std::vector< int >::value_type const & x)"""
-        return _libBornAgainParam.vector_integer_t_append(self, x)
+        r"""append(vector_integer_T self, std::vector< int >::value_type const & x)"""
+        return _libBornAgainParam.vector_integer_T_append(self, x)
 
     def empty(self):
-        r"""empty(vector_integer_t self) -> bool"""
-        return _libBornAgainParam.vector_integer_t_empty(self)
+        r"""empty(vector_integer_T self) -> bool"""
+        return _libBornAgainParam.vector_integer_T_empty(self)
 
     def size(self):
-        r"""size(vector_integer_t self) -> std::vector< int >::size_type"""
-        return _libBornAgainParam.vector_integer_t_size(self)
+        r"""size(vector_integer_T self) -> std::vector< int >::size_type"""
+        return _libBornAgainParam.vector_integer_T_size(self)
 
     def swap(self, v):
-        r"""swap(vector_integer_t self, vector_integer_t v)"""
-        return _libBornAgainParam.vector_integer_t_swap(self, v)
+        r"""swap(vector_integer_T self, vector_integer_T v)"""
+        return _libBornAgainParam.vector_integer_T_swap(self, v)
 
     def begin(self):
-        r"""begin(vector_integer_t self) -> std::vector< int >::iterator"""
-        return _libBornAgainParam.vector_integer_t_begin(self)
+        r"""begin(vector_integer_T self) -> std::vector< int >::iterator"""
+        return _libBornAgainParam.vector_integer_T_begin(self)
 
     def end(self):
-        r"""end(vector_integer_t self) -> std::vector< int >::iterator"""
-        return _libBornAgainParam.vector_integer_t_end(self)
+        r"""end(vector_integer_T self) -> std::vector< int >::iterator"""
+        return _libBornAgainParam.vector_integer_T_end(self)
 
     def rbegin(self):
-        r"""rbegin(vector_integer_t self) -> std::vector< int >::reverse_iterator"""
-        return _libBornAgainParam.vector_integer_t_rbegin(self)
+        r"""rbegin(vector_integer_T self) -> std::vector< int >::reverse_iterator"""
+        return _libBornAgainParam.vector_integer_T_rbegin(self)
 
     def rend(self):
-        r"""rend(vector_integer_t self) -> std::vector< int >::reverse_iterator"""
-        return _libBornAgainParam.vector_integer_t_rend(self)
+        r"""rend(vector_integer_T self) -> std::vector< int >::reverse_iterator"""
+        return _libBornAgainParam.vector_integer_T_rend(self)
 
     def clear(self):
-        r"""clear(vector_integer_t self)"""
-        return _libBornAgainParam.vector_integer_t_clear(self)
+        r"""clear(vector_integer_T self)"""
+        return _libBornAgainParam.vector_integer_T_clear(self)
 
     def get_allocator(self):
-        r"""get_allocator(vector_integer_t self) -> std::vector< int >::allocator_type"""
-        return _libBornAgainParam.vector_integer_t_get_allocator(self)
+        r"""get_allocator(vector_integer_T self) -> std::vector< int >::allocator_type"""
+        return _libBornAgainParam.vector_integer_T_get_allocator(self)
 
     def pop_back(self):
-        r"""pop_back(vector_integer_t self)"""
-        return _libBornAgainParam.vector_integer_t_pop_back(self)
+        r"""pop_back(vector_integer_T self)"""
+        return _libBornAgainParam.vector_integer_T_pop_back(self)
 
     def erase(self, *args):
         r"""
-        erase(vector_integer_t self, std::vector< int >::iterator pos) -> std::vector< int >::iterator
-        erase(vector_integer_t self, std::vector< int >::iterator first, std::vector< int >::iterator last) -> std::vector< int >::iterator
+        erase(vector_integer_T self, std::vector< int >::iterator pos) -> std::vector< int >::iterator
+        erase(vector_integer_T self, std::vector< int >::iterator first, std::vector< int >::iterator last) -> std::vector< int >::iterator
         """
-        return _libBornAgainParam.vector_integer_t_erase(self, *args)
+        return _libBornAgainParam.vector_integer_T_erase(self, *args)
 
     def __init__(self, *args):
         r"""
-        __init__(vector_integer_t self) -> vector_integer_t
-        __init__(vector_integer_t self, vector_integer_t other) -> vector_integer_t
-        __init__(vector_integer_t self, std::vector< int >::size_type size) -> vector_integer_t
-        __init__(vector_integer_t self, std::vector< int >::size_type size, std::vector< int >::value_type const & value) -> vector_integer_t
+        __init__(vector_integer_T self) -> vector_integer_T
+        __init__(vector_integer_T self, vector_integer_T other) -> vector_integer_T
+        __init__(vector_integer_T self, std::vector< int >::size_type size) -> vector_integer_T
+        __init__(vector_integer_T self, std::vector< int >::size_type size, std::vector< int >::value_type const & value) -> vector_integer_T
         """
-        _libBornAgainParam.vector_integer_t_swiginit(self, _libBornAgainParam.new_vector_integer_t(*args))
+        _libBornAgainParam.vector_integer_T_swiginit(self, _libBornAgainParam.new_vector_integer_T(*args))
 
     def push_back(self, x):
-        r"""push_back(vector_integer_t self, std::vector< int >::value_type const & x)"""
-        return _libBornAgainParam.vector_integer_t_push_back(self, x)
+        r"""push_back(vector_integer_T self, std::vector< int >::value_type const & x)"""
+        return _libBornAgainParam.vector_integer_T_push_back(self, x)
 
     def front(self):
-        r"""front(vector_integer_t self) -> std::vector< int >::value_type const &"""
-        return _libBornAgainParam.vector_integer_t_front(self)
+        r"""front(vector_integer_T self) -> std::vector< int >::value_type const &"""
+        return _libBornAgainParam.vector_integer_T_front(self)
 
     def back(self):
-        r"""back(vector_integer_t self) -> std::vector< int >::value_type const &"""
-        return _libBornAgainParam.vector_integer_t_back(self)
+        r"""back(vector_integer_T self) -> std::vector< int >::value_type const &"""
+        return _libBornAgainParam.vector_integer_T_back(self)
 
     def assign(self, n, x):
-        r"""assign(vector_integer_t self, std::vector< int >::size_type n, std::vector< int >::value_type const & x)"""
-        return _libBornAgainParam.vector_integer_t_assign(self, n, x)
+        r"""assign(vector_integer_T self, std::vector< int >::size_type n, std::vector< int >::value_type const & x)"""
+        return _libBornAgainParam.vector_integer_T_assign(self, n, x)
 
     def resize(self, *args):
         r"""
-        resize(vector_integer_t self, std::vector< int >::size_type new_size)
-        resize(vector_integer_t self, std::vector< int >::size_type new_size, std::vector< int >::value_type const & x)
+        resize(vector_integer_T self, std::vector< int >::size_type new_size)
+        resize(vector_integer_T self, std::vector< int >::size_type new_size, std::vector< int >::value_type const & x)
         """
-        return _libBornAgainParam.vector_integer_t_resize(self, *args)
+        return _libBornAgainParam.vector_integer_T_resize(self, *args)
 
     def insert(self, *args):
         r"""
-        insert(vector_integer_t self, std::vector< int >::iterator pos, std::vector< int >::value_type const & x) -> std::vector< int >::iterator
-        insert(vector_integer_t self, std::vector< int >::iterator pos, std::vector< int >::size_type n, std::vector< int >::value_type const & x)
+        insert(vector_integer_T self, std::vector< int >::iterator pos, std::vector< int >::value_type const & x) -> std::vector< int >::iterator
+        insert(vector_integer_T self, std::vector< int >::iterator pos, std::vector< int >::size_type n, std::vector< int >::value_type const & x)
         """
-        return _libBornAgainParam.vector_integer_t_insert(self, *args)
+        return _libBornAgainParam.vector_integer_T_insert(self, *args)
 
     def reserve(self, n):
-        r"""reserve(vector_integer_t self, std::vector< int >::size_type n)"""
-        return _libBornAgainParam.vector_integer_t_reserve(self, n)
+        r"""reserve(vector_integer_T self, std::vector< int >::size_type n)"""
+        return _libBornAgainParam.vector_integer_T_reserve(self, n)
 
     def capacity(self):
-        r"""capacity(vector_integer_t self) -> std::vector< int >::size_type"""
-        return _libBornAgainParam.vector_integer_t_capacity(self)
-    __swig_destroy__ = _libBornAgainParam.delete_vector_integer_t
+        r"""capacity(vector_integer_T self) -> std::vector< int >::size_type"""
+        return _libBornAgainParam.vector_integer_T_capacity(self)
+    __swig_destroy__ = _libBornAgainParam.delete_vector_integer_T
 
-# Register vector_integer_t in _libBornAgainParam:
-_libBornAgainParam.vector_integer_t_swigregister(vector_integer_t)
-class vinteger2d_t(object):
+# Register vector_integer_T in _libBornAgainParam:
+_libBornAgainParam.vector_integer_T_swigregister(vector_integer_T)
+class vinteger2d_T(object):
     r"""Proxy of C++ std::vector< std::vector< int > > class."""
 
     thisown = property(lambda x: x.this.own(), lambda x, v: x.this.own(v), doc="The membership flag")
     __repr__ = _swig_repr
 
     def iterator(self):
-        r"""iterator(vinteger2d_t self) -> SwigPyIterator"""
-        return _libBornAgainParam.vinteger2d_t_iterator(self)
+        r"""iterator(vinteger2d_T self) -> SwigPyIterator"""
+        return _libBornAgainParam.vinteger2d_T_iterator(self)
     def __iter__(self):
         return self.iterator()
 
     def __nonzero__(self):
-        r"""__nonzero__(vinteger2d_t self) -> bool"""
-        return _libBornAgainParam.vinteger2d_t___nonzero__(self)
+        r"""__nonzero__(vinteger2d_T self) -> bool"""
+        return _libBornAgainParam.vinteger2d_T___nonzero__(self)
 
     def __bool__(self):
-        r"""__bool__(vinteger2d_t self) -> bool"""
-        return _libBornAgainParam.vinteger2d_t___bool__(self)
+        r"""__bool__(vinteger2d_T self) -> bool"""
+        return _libBornAgainParam.vinteger2d_T___bool__(self)
 
     def __len__(self):
-        r"""__len__(vinteger2d_t self) -> std::vector< std::vector< int > >::size_type"""
-        return _libBornAgainParam.vinteger2d_t___len__(self)
+        r"""__len__(vinteger2d_T self) -> std::vector< std::vector< int > >::size_type"""
+        return _libBornAgainParam.vinteger2d_T___len__(self)
 
     def __getslice__(self, i, j):
-        r"""__getslice__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j) -> vinteger2d_t"""
-        return _libBornAgainParam.vinteger2d_t___getslice__(self, i, j)
+        r"""__getslice__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j) -> vinteger2d_T"""
+        return _libBornAgainParam.vinteger2d_T___getslice__(self, i, j)
 
     def __setslice__(self, *args):
         r"""
-        __setslice__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j)
-        __setslice__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j, vinteger2d_t v)
+        __setslice__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j)
+        __setslice__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j, vinteger2d_T v)
         """
-        return _libBornAgainParam.vinteger2d_t___setslice__(self, *args)
+        return _libBornAgainParam.vinteger2d_T___setslice__(self, *args)
 
     def __delslice__(self, i, j):
-        r"""__delslice__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j)"""
-        return _libBornAgainParam.vinteger2d_t___delslice__(self, i, j)
+        r"""__delslice__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j)"""
+        return _libBornAgainParam.vinteger2d_T___delslice__(self, i, j)
 
     def __delitem__(self, *args):
         r"""
-        __delitem__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i)
-        __delitem__(vinteger2d_t self, SWIGPY_SLICEOBJECT * slice)
+        __delitem__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i)
+        __delitem__(vinteger2d_T self, SWIGPY_SLICEOBJECT * slice)
         """
-        return _libBornAgainParam.vinteger2d_t___delitem__(self, *args)
+        return _libBornAgainParam.vinteger2d_T___delitem__(self, *args)
 
     def __getitem__(self, *args):
         r"""
-        __getitem__(vinteger2d_t self, SWIGPY_SLICEOBJECT * slice) -> vinteger2d_t
-        __getitem__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i) -> vector_integer_t
+        __getitem__(vinteger2d_T self, SWIGPY_SLICEOBJECT * slice) -> vinteger2d_T
+        __getitem__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i) -> vector_integer_T
         """
-        return _libBornAgainParam.vinteger2d_t___getitem__(self, *args)
+        return _libBornAgainParam.vinteger2d_T___getitem__(self, *args)
 
     def __setitem__(self, *args):
         r"""
-        __setitem__(vinteger2d_t self, SWIGPY_SLICEOBJECT * slice, vinteger2d_t v)
-        __setitem__(vinteger2d_t self, SWIGPY_SLICEOBJECT * slice)
-        __setitem__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i, vector_integer_t x)
+        __setitem__(vinteger2d_T self, SWIGPY_SLICEOBJECT * slice, vinteger2d_T v)
+        __setitem__(vinteger2d_T self, SWIGPY_SLICEOBJECT * slice)
+        __setitem__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i, vector_integer_T x)
         """
-        return _libBornAgainParam.vinteger2d_t___setitem__(self, *args)
+        return _libBornAgainParam.vinteger2d_T___setitem__(self, *args)
 
     def pop(self):
-        r"""pop(vinteger2d_t self) -> vector_integer_t"""
-        return _libBornAgainParam.vinteger2d_t_pop(self)
+        r"""pop(vinteger2d_T self) -> vector_integer_T"""
+        return _libBornAgainParam.vinteger2d_T_pop(self)
 
     def append(self, x):
-        r"""append(vinteger2d_t self, vector_integer_t x)"""
-        return _libBornAgainParam.vinteger2d_t_append(self, x)
+        r"""append(vinteger2d_T self, vector_integer_T x)"""
+        return _libBornAgainParam.vinteger2d_T_append(self, x)
 
     def empty(self):
-        r"""empty(vinteger2d_t self) -> bool"""
-        return _libBornAgainParam.vinteger2d_t_empty(self)
+        r"""empty(vinteger2d_T self) -> bool"""
+        return _libBornAgainParam.vinteger2d_T_empty(self)
 
     def size(self):
-        r"""size(vinteger2d_t self) -> std::vector< std::vector< int > >::size_type"""
-        return _libBornAgainParam.vinteger2d_t_size(self)
+        r"""size(vinteger2d_T self) -> std::vector< std::vector< int > >::size_type"""
+        return _libBornAgainParam.vinteger2d_T_size(self)
 
     def swap(self, v):
-        r"""swap(vinteger2d_t self, vinteger2d_t v)"""
-        return _libBornAgainParam.vinteger2d_t_swap(self, v)
+        r"""swap(vinteger2d_T self, vinteger2d_T v)"""
+        return _libBornAgainParam.vinteger2d_T_swap(self, v)
 
     def begin(self):
-        r"""begin(vinteger2d_t self) -> std::vector< std::vector< int > >::iterator"""
-        return _libBornAgainParam.vinteger2d_t_begin(self)
+        r"""begin(vinteger2d_T self) -> std::vector< std::vector< int > >::iterator"""
+        return _libBornAgainParam.vinteger2d_T_begin(self)
 
     def end(self):
-        r"""end(vinteger2d_t self) -> std::vector< std::vector< int > >::iterator"""
-        return _libBornAgainParam.vinteger2d_t_end(self)
+        r"""end(vinteger2d_T self) -> std::vector< std::vector< int > >::iterator"""
+        return _libBornAgainParam.vinteger2d_T_end(self)
 
     def rbegin(self):
-        r"""rbegin(vinteger2d_t self) -> std::vector< std::vector< int > >::reverse_iterator"""
-        return _libBornAgainParam.vinteger2d_t_rbegin(self)
+        r"""rbegin(vinteger2d_T self) -> std::vector< std::vector< int > >::reverse_iterator"""
+        return _libBornAgainParam.vinteger2d_T_rbegin(self)
 
     def rend(self):
-        r"""rend(vinteger2d_t self) -> std::vector< std::vector< int > >::reverse_iterator"""
-        return _libBornAgainParam.vinteger2d_t_rend(self)
+        r"""rend(vinteger2d_T self) -> std::vector< std::vector< int > >::reverse_iterator"""
+        return _libBornAgainParam.vinteger2d_T_rend(self)
 
     def clear(self):
-        r"""clear(vinteger2d_t self)"""
-        return _libBornAgainParam.vinteger2d_t_clear(self)
+        r"""clear(vinteger2d_T self)"""
+        return _libBornAgainParam.vinteger2d_T_clear(self)
 
     def get_allocator(self):
-        r"""get_allocator(vinteger2d_t self) -> std::vector< std::vector< int > >::allocator_type"""
-        return _libBornAgainParam.vinteger2d_t_get_allocator(self)
+        r"""get_allocator(vinteger2d_T self) -> std::vector< std::vector< int > >::allocator_type"""
+        return _libBornAgainParam.vinteger2d_T_get_allocator(self)
 
     def pop_back(self):
-        r"""pop_back(vinteger2d_t self)"""
-        return _libBornAgainParam.vinteger2d_t_pop_back(self)
+        r"""pop_back(vinteger2d_T self)"""
+        return _libBornAgainParam.vinteger2d_T_pop_back(self)
 
     def erase(self, *args):
         r"""
-        erase(vinteger2d_t self, std::vector< std::vector< int > >::iterator pos) -> std::vector< std::vector< int > >::iterator
-        erase(vinteger2d_t self, std::vector< std::vector< int > >::iterator first, std::vector< std::vector< int > >::iterator last) -> std::vector< std::vector< int > >::iterator
+        erase(vinteger2d_T self, std::vector< std::vector< int > >::iterator pos) -> std::vector< std::vector< int > >::iterator
+        erase(vinteger2d_T self, std::vector< std::vector< int > >::iterator first, std::vector< std::vector< int > >::iterator last) -> std::vector< std::vector< int > >::iterator
         """
-        return _libBornAgainParam.vinteger2d_t_erase(self, *args)
+        return _libBornAgainParam.vinteger2d_T_erase(self, *args)
 
     def __init__(self, *args):
         r"""
-        __init__(vinteger2d_t self) -> vinteger2d_t
-        __init__(vinteger2d_t self, vinteger2d_t other) -> vinteger2d_t
-        __init__(vinteger2d_t self, std::vector< std::vector< int > >::size_type size) -> vinteger2d_t
-        __init__(vinteger2d_t self, std::vector< std::vector< int > >::size_type size, vector_integer_t value) -> vinteger2d_t
+        __init__(vinteger2d_T self) -> vinteger2d_T
+        __init__(vinteger2d_T self, vinteger2d_T other) -> vinteger2d_T
+        __init__(vinteger2d_T self, std::vector< std::vector< int > >::size_type size) -> vinteger2d_T
+        __init__(vinteger2d_T self, std::vector< std::vector< int > >::size_type size, vector_integer_T value) -> vinteger2d_T
         """
-        _libBornAgainParam.vinteger2d_t_swiginit(self, _libBornAgainParam.new_vinteger2d_t(*args))
+        _libBornAgainParam.vinteger2d_T_swiginit(self, _libBornAgainParam.new_vinteger2d_T(*args))
 
     def push_back(self, x):
-        r"""push_back(vinteger2d_t self, vector_integer_t x)"""
-        return _libBornAgainParam.vinteger2d_t_push_back(self, x)
+        r"""push_back(vinteger2d_T self, vector_integer_T x)"""
+        return _libBornAgainParam.vinteger2d_T_push_back(self, x)
 
     def front(self):
-        r"""front(vinteger2d_t self) -> vector_integer_t"""
-        return _libBornAgainParam.vinteger2d_t_front(self)
+        r"""front(vinteger2d_T self) -> vector_integer_T"""
+        return _libBornAgainParam.vinteger2d_T_front(self)
 
     def back(self):
-        r"""back(vinteger2d_t self) -> vector_integer_t"""
-        return _libBornAgainParam.vinteger2d_t_back(self)
+        r"""back(vinteger2d_T self) -> vector_integer_T"""
+        return _libBornAgainParam.vinteger2d_T_back(self)
 
     def assign(self, n, x):
-        r"""assign(vinteger2d_t self, std::vector< std::vector< int > >::size_type n, vector_integer_t x)"""
-        return _libBornAgainParam.vinteger2d_t_assign(self, n, x)
+        r"""assign(vinteger2d_T self, std::vector< std::vector< int > >::size_type n, vector_integer_T x)"""
+        return _libBornAgainParam.vinteger2d_T_assign(self, n, x)
 
     def resize(self, *args):
         r"""
-        resize(vinteger2d_t self, std::vector< std::vector< int > >::size_type new_size)
-        resize(vinteger2d_t self, std::vector< std::vector< int > >::size_type new_size, vector_integer_t x)
+        resize(vinteger2d_T self, std::vector< std::vector< int > >::size_type new_size)
+        resize(vinteger2d_T self, std::vector< std::vector< int > >::size_type new_size, vector_integer_T x)
         """
-        return _libBornAgainParam.vinteger2d_t_resize(self, *args)
+        return _libBornAgainParam.vinteger2d_T_resize(self, *args)
 
     def insert(self, *args):
         r"""
-        insert(vinteger2d_t self, std::vector< std::vector< int > >::iterator pos, vector_integer_t x) -> std::vector< std::vector< int > >::iterator
-        insert(vinteger2d_t self, std::vector< std::vector< int > >::iterator pos, std::vector< std::vector< int > >::size_type n, vector_integer_t x)
+        insert(vinteger2d_T self, std::vector< std::vector< int > >::iterator pos, vector_integer_T x) -> std::vector< std::vector< int > >::iterator
+        insert(vinteger2d_T self, std::vector< std::vector< int > >::iterator pos, std::vector< std::vector< int > >::size_type n, vector_integer_T x)
         """
-        return _libBornAgainParam.vinteger2d_t_insert(self, *args)
+        return _libBornAgainParam.vinteger2d_T_insert(self, *args)
 
     def reserve(self, n):
-        r"""reserve(vinteger2d_t self, std::vector< std::vector< int > >::size_type n)"""
-        return _libBornAgainParam.vinteger2d_t_reserve(self, n)
+        r"""reserve(vinteger2d_T self, std::vector< std::vector< int > >::size_type n)"""
+        return _libBornAgainParam.vinteger2d_T_reserve(self, n)
 
     def capacity(self):
-        r"""capacity(vinteger2d_t self) -> std::vector< std::vector< int > >::size_type"""
-        return _libBornAgainParam.vinteger2d_t_capacity(self)
-    __swig_destroy__ = _libBornAgainParam.delete_vinteger2d_t
+        r"""capacity(vinteger2d_T self) -> std::vector< std::vector< int > >::size_type"""
+        return _libBornAgainParam.vinteger2d_T_capacity(self)
+    __swig_destroy__ = _libBornAgainParam.delete_vinteger2d_T
 
-# Register vinteger2d_t in _libBornAgainParam:
-_libBornAgainParam.vinteger2d_t_swigregister(vinteger2d_t)
-class vector_longinteger_t(object):
+# Register vinteger2d_T in _libBornAgainParam:
+_libBornAgainParam.vinteger2d_T_swigregister(vinteger2d_T)
+class vector_longinteger_T(object):
     r"""Proxy of C++ std::vector< unsigned long > class."""
 
     thisown = property(lambda x: x.this.own(), lambda x, v: x.this.own(v), doc="The membership flag")
     __repr__ = _swig_repr
 
     def iterator(self):
-        r"""iterator(vector_longinteger_t self) -> SwigPyIterator"""
-        return _libBornAgainParam.vector_longinteger_t_iterator(self)
+        r"""iterator(vector_longinteger_T self) -> SwigPyIterator"""
+        return _libBornAgainParam.vector_longinteger_T_iterator(self)
     def __iter__(self):
         return self.iterator()
 
     def __nonzero__(self):
-        r"""__nonzero__(vector_longinteger_t self) -> bool"""
-        return _libBornAgainParam.vector_longinteger_t___nonzero__(self)
+        r"""__nonzero__(vector_longinteger_T self) -> bool"""
+        return _libBornAgainParam.vector_longinteger_T___nonzero__(self)
 
     def __bool__(self):
-        r"""__bool__(vector_longinteger_t self) -> bool"""
-        return _libBornAgainParam.vector_longinteger_t___bool__(self)
+        r"""__bool__(vector_longinteger_T self) -> bool"""
+        return _libBornAgainParam.vector_longinteger_T___bool__(self)
 
     def __len__(self):
-        r"""__len__(vector_longinteger_t self) -> std::vector< unsigned long >::size_type"""
-        return _libBornAgainParam.vector_longinteger_t___len__(self)
+        r"""__len__(vector_longinteger_T self) -> std::vector< unsigned long >::size_type"""
+        return _libBornAgainParam.vector_longinteger_T___len__(self)
 
     def __getslice__(self, i, j):
-        r"""__getslice__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j) -> vector_longinteger_t"""
-        return _libBornAgainParam.vector_longinteger_t___getslice__(self, i, j)
+        r"""__getslice__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j) -> vector_longinteger_T"""
+        return _libBornAgainParam.vector_longinteger_T___getslice__(self, i, j)
 
     def __setslice__(self, *args):
         r"""
-        __setslice__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j)
-        __setslice__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j, vector_longinteger_t v)
+        __setslice__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j)
+        __setslice__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j, vector_longinteger_T v)
         """
-        return _libBornAgainParam.vector_longinteger_t___setslice__(self, *args)
+        return _libBornAgainParam.vector_longinteger_T___setslice__(self, *args)
 
     def __delslice__(self, i, j):
-        r"""__delslice__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j)"""
-        return _libBornAgainParam.vector_longinteger_t___delslice__(self, i, j)
+        r"""__delslice__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j)"""
+        return _libBornAgainParam.vector_longinteger_T___delslice__(self, i, j)
 
     def __delitem__(self, *args):
         r"""
-        __delitem__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i)
-        __delitem__(vector_longinteger_t self, SWIGPY_SLICEOBJECT * slice)
+        __delitem__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i)
+        __delitem__(vector_longinteger_T self, SWIGPY_SLICEOBJECT * slice)
         """
-        return _libBornAgainParam.vector_longinteger_t___delitem__(self, *args)
+        return _libBornAgainParam.vector_longinteger_T___delitem__(self, *args)
 
     def __getitem__(self, *args):
         r"""
-        __getitem__(vector_longinteger_t self, SWIGPY_SLICEOBJECT * slice) -> vector_longinteger_t
-        __getitem__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i) -> std::vector< unsigned long >::value_type const &
+        __getitem__(vector_longinteger_T self, SWIGPY_SLICEOBJECT * slice) -> vector_longinteger_T
+        __getitem__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i) -> std::vector< unsigned long >::value_type const &
         """
-        return _libBornAgainParam.vector_longinteger_t___getitem__(self, *args)
+        return _libBornAgainParam.vector_longinteger_T___getitem__(self, *args)
 
     def __setitem__(self, *args):
         r"""
-        __setitem__(vector_longinteger_t self, SWIGPY_SLICEOBJECT * slice, vector_longinteger_t v)
-        __setitem__(vector_longinteger_t self, SWIGPY_SLICEOBJECT * slice)
-        __setitem__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::value_type const & x)
+        __setitem__(vector_longinteger_T self, SWIGPY_SLICEOBJECT * slice, vector_longinteger_T v)
+        __setitem__(vector_longinteger_T self, SWIGPY_SLICEOBJECT * slice)
+        __setitem__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::value_type const & x)
         """
-        return _libBornAgainParam.vector_longinteger_t___setitem__(self, *args)
+        return _libBornAgainParam.vector_longinteger_T___setitem__(self, *args)
 
     def pop(self):
-        r"""pop(vector_longinteger_t self) -> std::vector< unsigned long >::value_type"""
-        return _libBornAgainParam.vector_longinteger_t_pop(self)
+        r"""pop(vector_longinteger_T self) -> std::vector< unsigned long >::value_type"""
+        return _libBornAgainParam.vector_longinteger_T_pop(self)
 
     def append(self, x):
-        r"""append(vector_longinteger_t self, std::vector< unsigned long >::value_type const & x)"""
-        return _libBornAgainParam.vector_longinteger_t_append(self, x)
+        r"""append(vector_longinteger_T self, std::vector< unsigned long >::value_type const & x)"""
+        return _libBornAgainParam.vector_longinteger_T_append(self, x)
 
     def empty(self):
-        r"""empty(vector_longinteger_t self) -> bool"""
-        return _libBornAgainParam.vector_longinteger_t_empty(self)
+        r"""empty(vector_longinteger_T self) -> bool"""
+        return _libBornAgainParam.vector_longinteger_T_empty(self)
 
     def size(self):
-        r"""size(vector_longinteger_t self) -> std::vector< unsigned long >::size_type"""
-        return _libBornAgainParam.vector_longinteger_t_size(self)
+        r"""size(vector_longinteger_T self) -> std::vector< unsigned long >::size_type"""
+        return _libBornAgainParam.vector_longinteger_T_size(self)
 
     def swap(self, v):
-        r"""swap(vector_longinteger_t self, vector_longinteger_t v)"""
-        return _libBornAgainParam.vector_longinteger_t_swap(self, v)
+        r"""swap(vector_longinteger_T self, vector_longinteger_T v)"""
+        return _libBornAgainParam.vector_longinteger_T_swap(self, v)
 
     def begin(self):
-        r"""begin(vector_longinteger_t self) -> std::vector< unsigned long >::iterator"""
-        return _libBornAgainParam.vector_longinteger_t_begin(self)
+        r"""begin(vector_longinteger_T self) -> std::vector< unsigned long >::iterator"""
+        return _libBornAgainParam.vector_longinteger_T_begin(self)
 
     def end(self):
-        r"""end(vector_longinteger_t self) -> std::vector< unsigned long >::iterator"""
-        return _libBornAgainParam.vector_longinteger_t_end(self)
+        r"""end(vector_longinteger_T self) -> std::vector< unsigned long >::iterator"""
+        return _libBornAgainParam.vector_longinteger_T_end(self)
 
     def rbegin(self):
-        r"""rbegin(vector_longinteger_t self) -> std::vector< unsigned long >::reverse_iterator"""
-        return _libBornAgainParam.vector_longinteger_t_rbegin(self)
+        r"""rbegin(vector_longinteger_T self) -> std::vector< unsigned long >::reverse_iterator"""
+        return _libBornAgainParam.vector_longinteger_T_rbegin(self)
 
     def rend(self):
-        r"""rend(vector_longinteger_t self) -> std::vector< unsigned long >::reverse_iterator"""
-        return _libBornAgainParam.vector_longinteger_t_rend(self)
+        r"""rend(vector_longinteger_T self) -> std::vector< unsigned long >::reverse_iterator"""
+        return _libBornAgainParam.vector_longinteger_T_rend(self)
 
     def clear(self):
-        r"""clear(vector_longinteger_t self)"""
-        return _libBornAgainParam.vector_longinteger_t_clear(self)
+        r"""clear(vector_longinteger_T self)"""
+        return _libBornAgainParam.vector_longinteger_T_clear(self)
 
     def get_allocator(self):
-        r"""get_allocator(vector_longinteger_t self) -> std::vector< unsigned long >::allocator_type"""
-        return _libBornAgainParam.vector_longinteger_t_get_allocator(self)
+        r"""get_allocator(vector_longinteger_T self) -> std::vector< unsigned long >::allocator_type"""
+        return _libBornAgainParam.vector_longinteger_T_get_allocator(self)
 
     def pop_back(self):
-        r"""pop_back(vector_longinteger_t self)"""
-        return _libBornAgainParam.vector_longinteger_t_pop_back(self)
+        r"""pop_back(vector_longinteger_T self)"""
+        return _libBornAgainParam.vector_longinteger_T_pop_back(self)
 
     def erase(self, *args):
         r"""
-        erase(vector_longinteger_t self, std::vector< unsigned long >::iterator pos) -> std::vector< unsigned long >::iterator
-        erase(vector_longinteger_t self, std::vector< unsigned long >::iterator first, std::vector< unsigned long >::iterator last) -> std::vector< unsigned long >::iterator
+        erase(vector_longinteger_T self, std::vector< unsigned long >::iterator pos) -> std::vector< unsigned long >::iterator
+        erase(vector_longinteger_T self, std::vector< unsigned long >::iterator first, std::vector< unsigned long >::iterator last) -> std::vector< unsigned long >::iterator
         """
-        return _libBornAgainParam.vector_longinteger_t_erase(self, *args)
+        return _libBornAgainParam.vector_longinteger_T_erase(self, *args)
 
     def __init__(self, *args):
         r"""
-        __init__(vector_longinteger_t self) -> vector_longinteger_t
-        __init__(vector_longinteger_t self, vector_longinteger_t other) -> vector_longinteger_t
-        __init__(vector_longinteger_t self, std::vector< unsigned long >::size_type size) -> vector_longinteger_t
-        __init__(vector_longinteger_t self, std::vector< unsigned long >::size_type size, std::vector< unsigned long >::value_type const & value) -> vector_longinteger_t
+        __init__(vector_longinteger_T self) -> vector_longinteger_T
+        __init__(vector_longinteger_T self, vector_longinteger_T other) -> vector_longinteger_T
+        __init__(vector_longinteger_T self, std::vector< unsigned long >::size_type size) -> vector_longinteger_T
+        __init__(vector_longinteger_T self, std::vector< unsigned long >::size_type size, std::vector< unsigned long >::value_type const & value) -> vector_longinteger_T
         """
-        _libBornAgainParam.vector_longinteger_t_swiginit(self, _libBornAgainParam.new_vector_longinteger_t(*args))
+        _libBornAgainParam.vector_longinteger_T_swiginit(self, _libBornAgainParam.new_vector_longinteger_T(*args))
 
     def push_back(self, x):
-        r"""push_back(vector_longinteger_t self, std::vector< unsigned long >::value_type const & x)"""
-        return _libBornAgainParam.vector_longinteger_t_push_back(self, x)
+        r"""push_back(vector_longinteger_T self, std::vector< unsigned long >::value_type const & x)"""
+        return _libBornAgainParam.vector_longinteger_T_push_back(self, x)
 
     def front(self):
-        r"""front(vector_longinteger_t self) -> std::vector< unsigned long >::value_type const &"""
-        return _libBornAgainParam.vector_longinteger_t_front(self)
+        r"""front(vector_longinteger_T self) -> std::vector< unsigned long >::value_type const &"""
+        return _libBornAgainParam.vector_longinteger_T_front(self)
 
     def back(self):
-        r"""back(vector_longinteger_t self) -> std::vector< unsigned long >::value_type const &"""
-        return _libBornAgainParam.vector_longinteger_t_back(self)
+        r"""back(vector_longinteger_T self) -> std::vector< unsigned long >::value_type const &"""
+        return _libBornAgainParam.vector_longinteger_T_back(self)
 
     def assign(self, n, x):
-        r"""assign(vector_longinteger_t self, std::vector< unsigned long >::size_type n, std::vector< unsigned long >::value_type const & x)"""
-        return _libBornAgainParam.vector_longinteger_t_assign(self, n, x)
+        r"""assign(vector_longinteger_T self, std::vector< unsigned long >::size_type n, std::vector< unsigned long >::value_type const & x)"""
+        return _libBornAgainParam.vector_longinteger_T_assign(self, n, x)
 
     def resize(self, *args):
         r"""
-        resize(vector_longinteger_t self, std::vector< unsigned long >::size_type new_size)
-        resize(vector_longinteger_t self, std::vector< unsigned long >::size_type new_size, std::vector< unsigned long >::value_type const & x)
+        resize(vector_longinteger_T self, std::vector< unsigned long >::size_type new_size)
+        resize(vector_longinteger_T self, std::vector< unsigned long >::size_type new_size, std::vector< unsigned long >::value_type const & x)
         """
-        return _libBornAgainParam.vector_longinteger_t_resize(self, *args)
+        return _libBornAgainParam.vector_longinteger_T_resize(self, *args)
 
     def insert(self, *args):
         r"""
-        insert(vector_longinteger_t self, std::vector< unsigned long >::iterator pos, std::vector< unsigned long >::value_type const & x) -> std::vector< unsigned long >::iterator
-        insert(vector_longinteger_t self, std::vector< unsigned long >::iterator pos, std::vector< unsigned long >::size_type n, std::vector< unsigned long >::value_type const & x)
+        insert(vector_longinteger_T self, std::vector< unsigned long >::iterator pos, std::vector< unsigned long >::value_type const & x) -> std::vector< unsigned long >::iterator
+        insert(vector_longinteger_T self, std::vector< unsigned long >::iterator pos, std::vector< unsigned long >::size_type n, std::vector< unsigned long >::value_type const & x)
         """
-        return _libBornAgainParam.vector_longinteger_t_insert(self, *args)
+        return _libBornAgainParam.vector_longinteger_T_insert(self, *args)
 
     def reserve(self, n):
-        r"""reserve(vector_longinteger_t self, std::vector< unsigned long >::size_type n)"""
-        return _libBornAgainParam.vector_longinteger_t_reserve(self, n)
+        r"""reserve(vector_longinteger_T self, std::vector< unsigned long >::size_type n)"""
+        return _libBornAgainParam.vector_longinteger_T_reserve(self, n)
 
     def capacity(self):
-        r"""capacity(vector_longinteger_t self) -> std::vector< unsigned long >::size_type"""
-        return _libBornAgainParam.vector_longinteger_t_capacity(self)
-    __swig_destroy__ = _libBornAgainParam.delete_vector_longinteger_t
+        r"""capacity(vector_longinteger_T self) -> std::vector< unsigned long >::size_type"""
+        return _libBornAgainParam.vector_longinteger_T_capacity(self)
+    __swig_destroy__ = _libBornAgainParam.delete_vector_longinteger_T
 
-# Register vector_longinteger_t in _libBornAgainParam:
-_libBornAgainParam.vector_longinteger_t_swigregister(vector_longinteger_t)
-class vector_complex_t(object):
+# Register vector_longinteger_T in _libBornAgainParam:
+_libBornAgainParam.vector_longinteger_T_swigregister(vector_longinteger_T)
+class vector_complex_T(object):
     r"""Proxy of C++ std::vector< std::complex< double > > class."""
 
     thisown = property(lambda x: x.this.own(), lambda x, v: x.this.own(v), doc="The membership flag")
     __repr__ = _swig_repr
 
     def iterator(self):
-        r"""iterator(vector_complex_t self) -> SwigPyIterator"""
-        return _libBornAgainParam.vector_complex_t_iterator(self)
+        r"""iterator(vector_complex_T self) -> SwigPyIterator"""
+        return _libBornAgainParam.vector_complex_T_iterator(self)
     def __iter__(self):
         return self.iterator()
 
     def __nonzero__(self):
-        r"""__nonzero__(vector_complex_t self) -> bool"""
-        return _libBornAgainParam.vector_complex_t___nonzero__(self)
+        r"""__nonzero__(vector_complex_T self) -> bool"""
+        return _libBornAgainParam.vector_complex_T___nonzero__(self)
 
     def __bool__(self):
-        r"""__bool__(vector_complex_t self) -> bool"""
-        return _libBornAgainParam.vector_complex_t___bool__(self)
+        r"""__bool__(vector_complex_T self) -> bool"""
+        return _libBornAgainParam.vector_complex_T___bool__(self)
 
     def __len__(self):
-        r"""__len__(vector_complex_t self) -> std::vector< std::complex< double > >::size_type"""
-        return _libBornAgainParam.vector_complex_t___len__(self)
+        r"""__len__(vector_complex_T self) -> std::vector< std::complex< double > >::size_type"""
+        return _libBornAgainParam.vector_complex_T___len__(self)
 
     def __getslice__(self, i, j):
-        r"""__getslice__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j) -> vector_complex_t"""
-        return _libBornAgainParam.vector_complex_t___getslice__(self, i, j)
+        r"""__getslice__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j) -> vector_complex_T"""
+        return _libBornAgainParam.vector_complex_T___getslice__(self, i, j)
 
     def __setslice__(self, *args):
         r"""
-        __setslice__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j)
-        __setslice__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j, vector_complex_t v)
+        __setslice__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j)
+        __setslice__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j, vector_complex_T v)
         """
-        return _libBornAgainParam.vector_complex_t___setslice__(self, *args)
+        return _libBornAgainParam.vector_complex_T___setslice__(self, *args)
 
     def __delslice__(self, i, j):
-        r"""__delslice__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j)"""
-        return _libBornAgainParam.vector_complex_t___delslice__(self, i, j)
+        r"""__delslice__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j)"""
+        return _libBornAgainParam.vector_complex_T___delslice__(self, i, j)
 
     def __delitem__(self, *args):
         r"""
-        __delitem__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i)
-        __delitem__(vector_complex_t self, SWIGPY_SLICEOBJECT * slice)
+        __delitem__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i)
+        __delitem__(vector_complex_T self, SWIGPY_SLICEOBJECT * slice)
         """
-        return _libBornAgainParam.vector_complex_t___delitem__(self, *args)
+        return _libBornAgainParam.vector_complex_T___delitem__(self, *args)
 
     def __getitem__(self, *args):
         r"""
-        __getitem__(vector_complex_t self, SWIGPY_SLICEOBJECT * slice) -> vector_complex_t
-        __getitem__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i) -> std::vector< std::complex< double > >::value_type const &
+        __getitem__(vector_complex_T self, SWIGPY_SLICEOBJECT * slice) -> vector_complex_T
+        __getitem__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i) -> std::vector< std::complex< double > >::value_type const &
         """
-        return _libBornAgainParam.vector_complex_t___getitem__(self, *args)
+        return _libBornAgainParam.vector_complex_T___getitem__(self, *args)
 
     def __setitem__(self, *args):
         r"""
-        __setitem__(vector_complex_t self, SWIGPY_SLICEOBJECT * slice, vector_complex_t v)
-        __setitem__(vector_complex_t self, SWIGPY_SLICEOBJECT * slice)
-        __setitem__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::value_type const & x)
+        __setitem__(vector_complex_T self, SWIGPY_SLICEOBJECT * slice, vector_complex_T v)
+        __setitem__(vector_complex_T self, SWIGPY_SLICEOBJECT * slice)
+        __setitem__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::value_type const & x)
         """
-        return _libBornAgainParam.vector_complex_t___setitem__(self, *args)
+        return _libBornAgainParam.vector_complex_T___setitem__(self, *args)
 
     def pop(self):
-        r"""pop(vector_complex_t self) -> std::vector< std::complex< double > >::value_type"""
-        return _libBornAgainParam.vector_complex_t_pop(self)
+        r"""pop(vector_complex_T self) -> std::vector< std::complex< double > >::value_type"""
+        return _libBornAgainParam.vector_complex_T_pop(self)
 
     def append(self, x):
-        r"""append(vector_complex_t self, std::vector< std::complex< double > >::value_type const & x)"""
-        return _libBornAgainParam.vector_complex_t_append(self, x)
+        r"""append(vector_complex_T self, std::vector< std::complex< double > >::value_type const & x)"""
+        return _libBornAgainParam.vector_complex_T_append(self, x)
 
     def empty(self):
-        r"""empty(vector_complex_t self) -> bool"""
-        return _libBornAgainParam.vector_complex_t_empty(self)
+        r"""empty(vector_complex_T self) -> bool"""
+        return _libBornAgainParam.vector_complex_T_empty(self)
 
     def size(self):
-        r"""size(vector_complex_t self) -> std::vector< std::complex< double > >::size_type"""
-        return _libBornAgainParam.vector_complex_t_size(self)
+        r"""size(vector_complex_T self) -> std::vector< std::complex< double > >::size_type"""
+        return _libBornAgainParam.vector_complex_T_size(self)
 
     def swap(self, v):
-        r"""swap(vector_complex_t self, vector_complex_t v)"""
-        return _libBornAgainParam.vector_complex_t_swap(self, v)
+        r"""swap(vector_complex_T self, vector_complex_T v)"""
+        return _libBornAgainParam.vector_complex_T_swap(self, v)
 
     def begin(self):
-        r"""begin(vector_complex_t self) -> std::vector< std::complex< double > >::iterator"""
-        return _libBornAgainParam.vector_complex_t_begin(self)
+        r"""begin(vector_complex_T self) -> std::vector< std::complex< double > >::iterator"""
+        return _libBornAgainParam.vector_complex_T_begin(self)
 
     def end(self):
-        r"""end(vector_complex_t self) -> std::vector< std::complex< double > >::iterator"""
-        return _libBornAgainParam.vector_complex_t_end(self)
+        r"""end(vector_complex_T self) -> std::vector< std::complex< double > >::iterator"""
+        return _libBornAgainParam.vector_complex_T_end(self)
 
     def rbegin(self):
-        r"""rbegin(vector_complex_t self) -> std::vector< std::complex< double > >::reverse_iterator"""
-        return _libBornAgainParam.vector_complex_t_rbegin(self)
+        r"""rbegin(vector_complex_T self) -> std::vector< std::complex< double > >::reverse_iterator"""
+        return _libBornAgainParam.vector_complex_T_rbegin(self)
 
     def rend(self):
-        r"""rend(vector_complex_t self) -> std::vector< std::complex< double > >::reverse_iterator"""
-        return _libBornAgainParam.vector_complex_t_rend(self)
+        r"""rend(vector_complex_T self) -> std::vector< std::complex< double > >::reverse_iterator"""
+        return _libBornAgainParam.vector_complex_T_rend(self)
 
     def clear(self):
-        r"""clear(vector_complex_t self)"""
-        return _libBornAgainParam.vector_complex_t_clear(self)
+        r"""clear(vector_complex_T self)"""
+        return _libBornAgainParam.vector_complex_T_clear(self)
 
     def get_allocator(self):
-        r"""get_allocator(vector_complex_t self) -> std::vector< std::complex< double > >::allocator_type"""
-        return _libBornAgainParam.vector_complex_t_get_allocator(self)
+        r"""get_allocator(vector_complex_T self) -> std::vector< std::complex< double > >::allocator_type"""
+        return _libBornAgainParam.vector_complex_T_get_allocator(self)
 
     def pop_back(self):
-        r"""pop_back(vector_complex_t self)"""
-        return _libBornAgainParam.vector_complex_t_pop_back(self)
+        r"""pop_back(vector_complex_T self)"""
+        return _libBornAgainParam.vector_complex_T_pop_back(self)
 
     def erase(self, *args):
         r"""
-        erase(vector_complex_t self, std::vector< std::complex< double > >::iterator pos) -> std::vector< std::complex< double > >::iterator
-        erase(vector_complex_t self, std::vector< std::complex< double > >::iterator first, std::vector< std::complex< double > >::iterator last) -> std::vector< std::complex< double > >::iterator
+        erase(vector_complex_T self, std::vector< std::complex< double > >::iterator pos) -> std::vector< std::complex< double > >::iterator
+        erase(vector_complex_T self, std::vector< std::complex< double > >::iterator first, std::vector< std::complex< double > >::iterator last) -> std::vector< std::complex< double > >::iterator
         """
-        return _libBornAgainParam.vector_complex_t_erase(self, *args)
+        return _libBornAgainParam.vector_complex_T_erase(self, *args)
 
     def __init__(self, *args):
         r"""
-        __init__(vector_complex_t self) -> vector_complex_t
-        __init__(vector_complex_t self, vector_complex_t other) -> vector_complex_t
-        __init__(vector_complex_t self, std::vector< std::complex< double > >::size_type size) -> vector_complex_t
-        __init__(vector_complex_t self, std::vector< std::complex< double > >::size_type size, std::vector< std::complex< double > >::value_type const & value) -> vector_complex_t
+        __init__(vector_complex_T self) -> vector_complex_T
+        __init__(vector_complex_T self, vector_complex_T other) -> vector_complex_T
+        __init__(vector_complex_T self, std::vector< std::complex< double > >::size_type size) -> vector_complex_T
+        __init__(vector_complex_T self, std::vector< std::complex< double > >::size_type size, std::vector< std::complex< double > >::value_type const & value) -> vector_complex_T
         """
-        _libBornAgainParam.vector_complex_t_swiginit(self, _libBornAgainParam.new_vector_complex_t(*args))
+        _libBornAgainParam.vector_complex_T_swiginit(self, _libBornAgainParam.new_vector_complex_T(*args))
 
     def push_back(self, x):
-        r"""push_back(vector_complex_t self, std::vector< std::complex< double > >::value_type const & x)"""
-        return _libBornAgainParam.vector_complex_t_push_back(self, x)
+        r"""push_back(vector_complex_T self, std::vector< std::complex< double > >::value_type const & x)"""
+        return _libBornAgainParam.vector_complex_T_push_back(self, x)
 
     def front(self):
-        r"""front(vector_complex_t self) -> std::vector< std::complex< double > >::value_type const &"""
-        return _libBornAgainParam.vector_complex_t_front(self)
+        r"""front(vector_complex_T self) -> std::vector< std::complex< double > >::value_type const &"""
+        return _libBornAgainParam.vector_complex_T_front(self)
 
     def back(self):
-        r"""back(vector_complex_t self) -> std::vector< std::complex< double > >::value_type const &"""
-        return _libBornAgainParam.vector_complex_t_back(self)
+        r"""back(vector_complex_T self) -> std::vector< std::complex< double > >::value_type const &"""
+        return _libBornAgainParam.vector_complex_T_back(self)
 
     def assign(self, n, x):
-        r"""assign(vector_complex_t self, std::vector< std::complex< double > >::size_type n, std::vector< std::complex< double > >::value_type const & x)"""
-        return _libBornAgainParam.vector_complex_t_assign(self, n, x)
+        r"""assign(vector_complex_T self, std::vector< std::complex< double > >::size_type n, std::vector< std::complex< double > >::value_type const & x)"""
+        return _libBornAgainParam.vector_complex_T_assign(self, n, x)
 
     def resize(self, *args):
         r"""
-        resize(vector_complex_t self, std::vector< std::complex< double > >::size_type new_size)
-        resize(vector_complex_t self, std::vector< std::complex< double > >::size_type new_size, std::vector< std::complex< double > >::value_type const & x)
+        resize(vector_complex_T self, std::vector< std::complex< double > >::size_type new_size)
+        resize(vector_complex_T self, std::vector< std::complex< double > >::size_type new_size, std::vector< std::complex< double > >::value_type const & x)
         """
-        return _libBornAgainParam.vector_complex_t_resize(self, *args)
+        return _libBornAgainParam.vector_complex_T_resize(self, *args)
 
     def insert(self, *args):
         r"""
-        insert(vector_complex_t self, std::vector< std::complex< double > >::iterator pos, std::vector< std::complex< double > >::value_type const & x) -> std::vector< std::complex< double > >::iterator
-        insert(vector_complex_t self, std::vector< std::complex< double > >::iterator pos, std::vector< std::complex< double > >::size_type n, std::vector< std::complex< double > >::value_type const & x)
+        insert(vector_complex_T self, std::vector< std::complex< double > >::iterator pos, std::vector< std::complex< double > >::value_type const & x) -> std::vector< std::complex< double > >::iterator
+        insert(vector_complex_T self, std::vector< std::complex< double > >::iterator pos, std::vector< std::complex< double > >::size_type n, std::vector< std::complex< double > >::value_type const & x)
         """
-        return _libBornAgainParam.vector_complex_t_insert(self, *args)
+        return _libBornAgainParam.vector_complex_T_insert(self, *args)
 
     def reserve(self, n):
-        r"""reserve(vector_complex_t self, std::vector< std::complex< double > >::size_type n)"""
-        return _libBornAgainParam.vector_complex_t_reserve(self, n)
+        r"""reserve(vector_complex_T self, std::vector< std::complex< double > >::size_type n)"""
+        return _libBornAgainParam.vector_complex_T_reserve(self, n)
 
     def capacity(self):
-        r"""capacity(vector_complex_t self) -> std::vector< std::complex< double > >::size_type"""
-        return _libBornAgainParam.vector_complex_t_capacity(self)
-    __swig_destroy__ = _libBornAgainParam.delete_vector_complex_t
+        r"""capacity(vector_complex_T self) -> std::vector< std::complex< double > >::size_type"""
+        return _libBornAgainParam.vector_complex_T_capacity(self)
+    __swig_destroy__ = _libBornAgainParam.delete_vector_complex_T
 
-# Register vector_complex_t in _libBornAgainParam:
-_libBornAgainParam.vector_complex_t_swigregister(vector_complex_t)
-class vector_string_t(object):
+# Register vector_complex_T in _libBornAgainParam:
+_libBornAgainParam.vector_complex_T_swigregister(vector_complex_T)
+class vector_string_T(object):
     r"""Proxy of C++ std::vector< std::string > class."""
 
     thisown = property(lambda x: x.this.own(), lambda x, v: x.this.own(v), doc="The membership flag")
     __repr__ = _swig_repr
 
     def iterator(self):
-        r"""iterator(vector_string_t self) -> SwigPyIterator"""
-        return _libBornAgainParam.vector_string_t_iterator(self)
+        r"""iterator(vector_string_T self) -> SwigPyIterator"""
+        return _libBornAgainParam.vector_string_T_iterator(self)
     def __iter__(self):
         return self.iterator()
 
     def __nonzero__(self):
-        r"""__nonzero__(vector_string_t self) -> bool"""
-        return _libBornAgainParam.vector_string_t___nonzero__(self)
+        r"""__nonzero__(vector_string_T self) -> bool"""
+        return _libBornAgainParam.vector_string_T___nonzero__(self)
 
     def __bool__(self):
-        r"""__bool__(vector_string_t self) -> bool"""
-        return _libBornAgainParam.vector_string_t___bool__(self)
+        r"""__bool__(vector_string_T self) -> bool"""
+        return _libBornAgainParam.vector_string_T___bool__(self)
 
     def __len__(self):
-        r"""__len__(vector_string_t self) -> std::vector< std::string >::size_type"""
-        return _libBornAgainParam.vector_string_t___len__(self)
+        r"""__len__(vector_string_T self) -> std::vector< std::string >::size_type"""
+        return _libBornAgainParam.vector_string_T___len__(self)
 
     def __getslice__(self, i, j):
-        r"""__getslice__(vector_string_t self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j) -> vector_string_t"""
-        return _libBornAgainParam.vector_string_t___getslice__(self, i, j)
+        r"""__getslice__(vector_string_T self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j) -> vector_string_T"""
+        return _libBornAgainParam.vector_string_T___getslice__(self, i, j)
 
     def __setslice__(self, *args):
         r"""
-        __setslice__(vector_string_t self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j)
-        __setslice__(vector_string_t self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j, vector_string_t v)
+        __setslice__(vector_string_T self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j)
+        __setslice__(vector_string_T self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j, vector_string_T v)
         """
-        return _libBornAgainParam.vector_string_t___setslice__(self, *args)
+        return _libBornAgainParam.vector_string_T___setslice__(self, *args)
 
     def __delslice__(self, i, j):
-        r"""__delslice__(vector_string_t self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j)"""
-        return _libBornAgainParam.vector_string_t___delslice__(self, i, j)
+        r"""__delslice__(vector_string_T self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j)"""
+        return _libBornAgainParam.vector_string_T___delslice__(self, i, j)
 
     def __delitem__(self, *args):
         r"""
-        __delitem__(vector_string_t self, std::vector< std::string >::difference_type i)
-        __delitem__(vector_string_t self, SWIGPY_SLICEOBJECT * slice)
+        __delitem__(vector_string_T self, std::vector< std::string >::difference_type i)
+        __delitem__(vector_string_T self, SWIGPY_SLICEOBJECT * slice)
         """
-        return _libBornAgainParam.vector_string_t___delitem__(self, *args)
+        return _libBornAgainParam.vector_string_T___delitem__(self, *args)
 
     def __getitem__(self, *args):
         r"""
-        __getitem__(vector_string_t self, SWIGPY_SLICEOBJECT * slice) -> vector_string_t
-        __getitem__(vector_string_t self, std::vector< std::string >::difference_type i) -> std::vector< std::string >::value_type const &
+        __getitem__(vector_string_T self, SWIGPY_SLICEOBJECT * slice) -> vector_string_T
+        __getitem__(vector_string_T self, std::vector< std::string >::difference_type i) -> std::vector< std::string >::value_type const &
         """
-        return _libBornAgainParam.vector_string_t___getitem__(self, *args)
+        return _libBornAgainParam.vector_string_T___getitem__(self, *args)
 
     def __setitem__(self, *args):
         r"""
-        __setitem__(vector_string_t self, SWIGPY_SLICEOBJECT * slice, vector_string_t v)
-        __setitem__(vector_string_t self, SWIGPY_SLICEOBJECT * slice)
-        __setitem__(vector_string_t self, std::vector< std::string >::difference_type i, std::vector< std::string >::value_type const & x)
+        __setitem__(vector_string_T self, SWIGPY_SLICEOBJECT * slice, vector_string_T v)
+        __setitem__(vector_string_T self, SWIGPY_SLICEOBJECT * slice)
+        __setitem__(vector_string_T self, std::vector< std::string >::difference_type i, std::vector< std::string >::value_type const & x)
         """
-        return _libBornAgainParam.vector_string_t___setitem__(self, *args)
+        return _libBornAgainParam.vector_string_T___setitem__(self, *args)
 
     def pop(self):
-        r"""pop(vector_string_t self) -> std::vector< std::string >::value_type"""
-        return _libBornAgainParam.vector_string_t_pop(self)
+        r"""pop(vector_string_T self) -> std::vector< std::string >::value_type"""
+        return _libBornAgainParam.vector_string_T_pop(self)
 
     def append(self, x):
-        r"""append(vector_string_t self, std::vector< std::string >::value_type const & x)"""
-        return _libBornAgainParam.vector_string_t_append(self, x)
+        r"""append(vector_string_T self, std::vector< std::string >::value_type const & x)"""
+        return _libBornAgainParam.vector_string_T_append(self, x)
 
     def empty(self):
-        r"""empty(vector_string_t self) -> bool"""
-        return _libBornAgainParam.vector_string_t_empty(self)
+        r"""empty(vector_string_T self) -> bool"""
+        return _libBornAgainParam.vector_string_T_empty(self)
 
     def size(self):
-        r"""size(vector_string_t self) -> std::vector< std::string >::size_type"""
-        return _libBornAgainParam.vector_string_t_size(self)
+        r"""size(vector_string_T self) -> std::vector< std::string >::size_type"""
+        return _libBornAgainParam.vector_string_T_size(self)
 
     def swap(self, v):
-        r"""swap(vector_string_t self, vector_string_t v)"""
-        return _libBornAgainParam.vector_string_t_swap(self, v)
+        r"""swap(vector_string_T self, vector_string_T v)"""
+        return _libBornAgainParam.vector_string_T_swap(self, v)
 
     def begin(self):
-        r"""begin(vector_string_t self) -> std::vector< std::string >::iterator"""
-        return _libBornAgainParam.vector_string_t_begin(self)
+        r"""begin(vector_string_T self) -> std::vector< std::string >::iterator"""
+        return _libBornAgainParam.vector_string_T_begin(self)
 
     def end(self):
-        r"""end(vector_string_t self) -> std::vector< std::string >::iterator"""
-        return _libBornAgainParam.vector_string_t_end(self)
+        r"""end(vector_string_T self) -> std::vector< std::string >::iterator"""
+        return _libBornAgainParam.vector_string_T_end(self)
 
     def rbegin(self):
-        r"""rbegin(vector_string_t self) -> std::vector< std::string >::reverse_iterator"""
-        return _libBornAgainParam.vector_string_t_rbegin(self)
+        r"""rbegin(vector_string_T self) -> std::vector< std::string >::reverse_iterator"""
+        return _libBornAgainParam.vector_string_T_rbegin(self)
 
     def rend(self):
-        r"""rend(vector_string_t self) -> std::vector< std::string >::reverse_iterator"""
-        return _libBornAgainParam.vector_string_t_rend(self)
+        r"""rend(vector_string_T self) -> std::vector< std::string >::reverse_iterator"""
+        return _libBornAgainParam.vector_string_T_rend(self)
 
     def clear(self):
-        r"""clear(vector_string_t self)"""
-        return _libBornAgainParam.vector_string_t_clear(self)
+        r"""clear(vector_string_T self)"""
+        return _libBornAgainParam.vector_string_T_clear(self)
 
     def get_allocator(self):
-        r"""get_allocator(vector_string_t self) -> std::vector< std::string >::allocator_type"""
-        return _libBornAgainParam.vector_string_t_get_allocator(self)
+        r"""get_allocator(vector_string_T self) -> std::vector< std::string >::allocator_type"""
+        return _libBornAgainParam.vector_string_T_get_allocator(self)
 
     def pop_back(self):
-        r"""pop_back(vector_string_t self)"""
-        return _libBornAgainParam.vector_string_t_pop_back(self)
+        r"""pop_back(vector_string_T self)"""
+        return _libBornAgainParam.vector_string_T_pop_back(self)
 
     def erase(self, *args):
         r"""
-        erase(vector_string_t self, std::vector< std::string >::iterator pos) -> std::vector< std::string >::iterator
-        erase(vector_string_t self, std::vector< std::string >::iterator first, std::vector< std::string >::iterator last) -> std::vector< std::string >::iterator
+        erase(vector_string_T self, std::vector< std::string >::iterator pos) -> std::vector< std::string >::iterator
+        erase(vector_string_T self, std::vector< std::string >::iterator first, std::vector< std::string >::iterator last) -> std::vector< std::string >::iterator
         """
-        return _libBornAgainParam.vector_string_t_erase(self, *args)
+        return _libBornAgainParam.vector_string_T_erase(self, *args)
 
     def __init__(self, *args):
         r"""
-        __init__(vector_string_t self) -> vector_string_t
-        __init__(vector_string_t self, vector_string_t other) -> vector_string_t
-        __init__(vector_string_t self, std::vector< std::string >::size_type size) -> vector_string_t
-        __init__(vector_string_t self, std::vector< std::string >::size_type size, std::vector< std::string >::value_type const & value) -> vector_string_t
+        __init__(vector_string_T self) -> vector_string_T
+        __init__(vector_string_T self, vector_string_T other) -> vector_string_T
+        __init__(vector_string_T self, std::vector< std::string >::size_type size) -> vector_string_T
+        __init__(vector_string_T self, std::vector< std::string >::size_type size, std::vector< std::string >::value_type const & value) -> vector_string_T
         """
-        _libBornAgainParam.vector_string_t_swiginit(self, _libBornAgainParam.new_vector_string_t(*args))
+        _libBornAgainParam.vector_string_T_swiginit(self, _libBornAgainParam.new_vector_string_T(*args))
 
     def push_back(self, x):
-        r"""push_back(vector_string_t self, std::vector< std::string >::value_type const & x)"""
-        return _libBornAgainParam.vector_string_t_push_back(self, x)
+        r"""push_back(vector_string_T self, std::vector< std::string >::value_type const & x)"""
+        return _libBornAgainParam.vector_string_T_push_back(self, x)
 
     def front(self):
-        r"""front(vector_string_t self) -> std::vector< std::string >::value_type const &"""
-        return _libBornAgainParam.vector_string_t_front(self)
+        r"""front(vector_string_T self) -> std::vector< std::string >::value_type const &"""
+        return _libBornAgainParam.vector_string_T_front(self)
 
     def back(self):
-        r"""back(vector_string_t self) -> std::vector< std::string >::value_type const &"""
-        return _libBornAgainParam.vector_string_t_back(self)
+        r"""back(vector_string_T self) -> std::vector< std::string >::value_type const &"""
+        return _libBornAgainParam.vector_string_T_back(self)
 
     def assign(self, n, x):
-        r"""assign(vector_string_t self, std::vector< std::string >::size_type n, std::vector< std::string >::value_type const & x)"""
-        return _libBornAgainParam.vector_string_t_assign(self, n, x)
+        r"""assign(vector_string_T self, std::vector< std::string >::size_type n, std::vector< std::string >::value_type const & x)"""
+        return _libBornAgainParam.vector_string_T_assign(self, n, x)
 
     def resize(self, *args):
         r"""
-        resize(vector_string_t self, std::vector< std::string >::size_type new_size)
-        resize(vector_string_t self, std::vector< std::string >::size_type new_size, std::vector< std::string >::value_type const & x)
+        resize(vector_string_T self, std::vector< std::string >::size_type new_size)
+        resize(vector_string_T self, std::vector< std::string >::size_type new_size, std::vector< std::string >::value_type const & x)
         """
-        return _libBornAgainParam.vector_string_t_resize(self, *args)
+        return _libBornAgainParam.vector_string_T_resize(self, *args)
 
     def insert(self, *args):
         r"""
-        insert(vector_string_t self, std::vector< std::string >::iterator pos, std::vector< std::string >::value_type const & x) -> std::vector< std::string >::iterator
-        insert(vector_string_t self, std::vector< std::string >::iterator pos, std::vector< std::string >::size_type n, std::vector< std::string >::value_type const & x)
+        insert(vector_string_T self, std::vector< std::string >::iterator pos, std::vector< std::string >::value_type const & x) -> std::vector< std::string >::iterator
+        insert(vector_string_T self, std::vector< std::string >::iterator pos, std::vector< std::string >::size_type n, std::vector< std::string >::value_type const & x)
         """
-        return _libBornAgainParam.vector_string_t_insert(self, *args)
+        return _libBornAgainParam.vector_string_T_insert(self, *args)
 
     def reserve(self, n):
-        r"""reserve(vector_string_t self, std::vector< std::string >::size_type n)"""
-        return _libBornAgainParam.vector_string_t_reserve(self, n)
+        r"""reserve(vector_string_T self, std::vector< std::string >::size_type n)"""
+        return _libBornAgainParam.vector_string_T_reserve(self, n)
 
     def capacity(self):
-        r"""capacity(vector_string_t self) -> std::vector< std::string >::size_type"""
-        return _libBornAgainParam.vector_string_t_capacity(self)
-    __swig_destroy__ = _libBornAgainParam.delete_vector_string_t
+        r"""capacity(vector_string_T self) -> std::vector< std::string >::size_type"""
+        return _libBornAgainParam.vector_string_T_capacity(self)
+    __swig_destroy__ = _libBornAgainParam.delete_vector_string_T
 
-# Register vector_string_t in _libBornAgainParam:
-_libBornAgainParam.vector_string_t_swigregister(vector_string_t)
-class map_string_double_t(object):
+# Register vector_string_T in _libBornAgainParam:
+_libBornAgainParam.vector_string_T_swigregister(vector_string_T)
+class map_string_double_T(object):
     r"""Proxy of C++ std::map< std::string,double > class."""
 
     thisown = property(lambda x: x.this.own(), lambda x, v: x.this.own(v), doc="The membership flag")
     __repr__ = _swig_repr
 
     def iterator(self):
-        r"""iterator(map_string_double_t self) -> SwigPyIterator"""
-        return _libBornAgainParam.map_string_double_t_iterator(self)
+        r"""iterator(map_string_double_T self) -> SwigPyIterator"""
+        return _libBornAgainParam.map_string_double_T_iterator(self)
     def __iter__(self):
         return self.iterator()
 
     def __nonzero__(self):
-        r"""__nonzero__(map_string_double_t self) -> bool"""
-        return _libBornAgainParam.map_string_double_t___nonzero__(self)
+        r"""__nonzero__(map_string_double_T self) -> bool"""
+        return _libBornAgainParam.map_string_double_T___nonzero__(self)
 
     def __bool__(self):
-        r"""__bool__(map_string_double_t self) -> bool"""
-        return _libBornAgainParam.map_string_double_t___bool__(self)
+        r"""__bool__(map_string_double_T self) -> bool"""
+        return _libBornAgainParam.map_string_double_T___bool__(self)
 
     def __len__(self):
-        r"""__len__(map_string_double_t self) -> std::map< std::string,double >::size_type"""
-        return _libBornAgainParam.map_string_double_t___len__(self)
+        r"""__len__(map_string_double_T self) -> std::map< std::string,double >::size_type"""
+        return _libBornAgainParam.map_string_double_T___len__(self)
     def __iter__(self):
         return self.key_iterator()
     def iterkeys(self):
@@ -1348,124 +1348,124 @@ class map_string_double_t(object):
         return self.iterator()
 
     def __getitem__(self, key):
-        r"""__getitem__(map_string_double_t self, std::map< std::string,double >::key_type const & key) -> std::map< std::string,double >::mapped_type const &"""
-        return _libBornAgainParam.map_string_double_t___getitem__(self, key)
+        r"""__getitem__(map_string_double_T self, std::map< std::string,double >::key_type const & key) -> std::map< std::string,double >::mapped_type const &"""
+        return _libBornAgainParam.map_string_double_T___getitem__(self, key)
 
     def __delitem__(self, key):
-        r"""__delitem__(map_string_double_t self, std::map< std::string,double >::key_type const & key)"""
-        return _libBornAgainParam.map_string_double_t___delitem__(self, key)
+        r"""__delitem__(map_string_double_T self, std::map< std::string,double >::key_type const & key)"""
+        return _libBornAgainParam.map_string_double_T___delitem__(self, key)
 
     def has_key(self, key):
-        r"""has_key(map_string_double_t self, std::map< std::string,double >::key_type const & key) -> bool"""
-        return _libBornAgainParam.map_string_double_t_has_key(self, key)
+        r"""has_key(map_string_double_T self, std::map< std::string,double >::key_type const & key) -> bool"""
+        return _libBornAgainParam.map_string_double_T_has_key(self, key)
 
     def keys(self):
-        r"""keys(map_string_double_t self) -> PyObject *"""
-        return _libBornAgainParam.map_string_double_t_keys(self)
+        r"""keys(map_string_double_T self) -> PyObject *"""
+        return _libBornAgainParam.map_string_double_T_keys(self)
 
     def values(self):
-        r"""values(map_string_double_t self) -> PyObject *"""
-        return _libBornAgainParam.map_string_double_t_values(self)
+        r"""values(map_string_double_T self) -> PyObject *"""
+        return _libBornAgainParam.map_string_double_T_values(self)
 
     def items(self):
-        r"""items(map_string_double_t self) -> PyObject *"""
-        return _libBornAgainParam.map_string_double_t_items(self)
+        r"""items(map_string_double_T self) -> PyObject *"""
+        return _libBornAgainParam.map_string_double_T_items(self)
 
     def __contains__(self, key):
-        r"""__contains__(map_string_double_t self, std::map< std::string,double >::key_type const & key) -> bool"""
-        return _libBornAgainParam.map_string_double_t___contains__(self, key)
+        r"""__contains__(map_string_double_T self, std::map< std::string,double >::key_type const & key) -> bool"""
+        return _libBornAgainParam.map_string_double_T___contains__(self, key)
 
     def key_iterator(self):
-        r"""key_iterator(map_string_double_t self) -> SwigPyIterator"""
-        return _libBornAgainParam.map_string_double_t_key_iterator(self)
+        r"""key_iterator(map_string_double_T self) -> SwigPyIterator"""
+        return _libBornAgainParam.map_string_double_T_key_iterator(self)
 
     def value_iterator(self):
-        r"""value_iterator(map_string_double_t self) -> SwigPyIterator"""
-        return _libBornAgainParam.map_string_double_t_value_iterator(self)
+        r"""value_iterator(map_string_double_T self) -> SwigPyIterator"""
+        return _libBornAgainParam.map_string_double_T_value_iterator(self)
 
     def __setitem__(self, *args):
         r"""
-        __setitem__(map_string_double_t self, std::map< std::string,double >::key_type const & key)
-        __setitem__(map_string_double_t self, std::map< std::string,double >::key_type const & key, std::map< std::string,double >::mapped_type const & x)
+        __setitem__(map_string_double_T self, std::map< std::string,double >::key_type const & key)
+        __setitem__(map_string_double_T self, std::map< std::string,double >::key_type const & key, std::map< std::string,double >::mapped_type const & x)
         """
-        return _libBornAgainParam.map_string_double_t___setitem__(self, *args)
+        return _libBornAgainParam.map_string_double_T___setitem__(self, *args)
 
     def asdict(self):
-        r"""asdict(map_string_double_t self) -> PyObject *"""
-        return _libBornAgainParam.map_string_double_t_asdict(self)
+        r"""asdict(map_string_double_T self) -> PyObject *"""
+        return _libBornAgainParam.map_string_double_T_asdict(self)
 
     def __init__(self, *args):
         r"""
-        __init__(map_string_double_t self, std::less< std::string > const & other) -> map_string_double_t
-        __init__(map_string_double_t self) -> map_string_double_t
-        __init__(map_string_double_t self, map_string_double_t other) -> map_string_double_t
+        __init__(map_string_double_T self, std::less< std::string > const & other) -> map_string_double_T
+        __init__(map_string_double_T self) -> map_string_double_T
+        __init__(map_string_double_T self, map_string_double_T other) -> map_string_double_T
         """
-        _libBornAgainParam.map_string_double_t_swiginit(self, _libBornAgainParam.new_map_string_double_t(*args))
+        _libBornAgainParam.map_string_double_T_swiginit(self, _libBornAgainParam.new_map_string_double_T(*args))
 
     def empty(self):
-        r"""empty(map_string_double_t self) -> bool"""
-        return _libBornAgainParam.map_string_double_t_empty(self)
+        r"""empty(map_string_double_T self) -> bool"""
+        return _libBornAgainParam.map_string_double_T_empty(self)
 
     def size(self):
-        r"""size(map_string_double_t self) -> std::map< std::string,double >::size_type"""
-        return _libBornAgainParam.map_string_double_t_size(self)
+        r"""size(map_string_double_T self) -> std::map< std::string,double >::size_type"""
+        return _libBornAgainParam.map_string_double_T_size(self)
 
     def swap(self, v):
-        r"""swap(map_string_double_t self, map_string_double_t v)"""
-        return _libBornAgainParam.map_string_double_t_swap(self, v)
+        r"""swap(map_string_double_T self, map_string_double_T v)"""
+        return _libBornAgainParam.map_string_double_T_swap(self, v)
 
     def begin(self):
-        r"""begin(map_string_double_t self) -> std::map< std::string,double >::iterator"""
-        return _libBornAgainParam.map_string_double_t_begin(self)
+        r"""begin(map_string_double_T self) -> std::map< std::string,double >::iterator"""
+        return _libBornAgainParam.map_string_double_T_begin(self)
 
     def end(self):
-        r"""end(map_string_double_t self) -> std::map< std::string,double >::iterator"""
-        return _libBornAgainParam.map_string_double_t_end(self)
+        r"""end(map_string_double_T self) -> std::map< std::string,double >::iterator"""
+        return _libBornAgainParam.map_string_double_T_end(self)
 
     def rbegin(self):
-        r"""rbegin(map_string_double_t self) -> std::map< std::string,double >::reverse_iterator"""
-        return _libBornAgainParam.map_string_double_t_rbegin(self)
+        r"""rbegin(map_string_double_T self) -> std::map< std::string,double >::reverse_iterator"""
+        return _libBornAgainParam.map_string_double_T_rbegin(self)
 
     def rend(self):
-        r"""rend(map_string_double_t self) -> std::map< std::string,double >::reverse_iterator"""
-        return _libBornAgainParam.map_string_double_t_rend(self)
+        r"""rend(map_string_double_T self) -> std::map< std::string,double >::reverse_iterator"""
+        return _libBornAgainParam.map_string_double_T_rend(self)
 
     def clear(self):
-        r"""clear(map_string_double_t self)"""
-        return _libBornAgainParam.map_string_double_t_clear(self)
+        r"""clear(map_string_double_T self)"""
+        return _libBornAgainParam.map_string_double_T_clear(self)
 
     def get_allocator(self):
-        r"""get_allocator(map_string_double_t self) -> std::map< std::string,double >::allocator_type"""
-        return _libBornAgainParam.map_string_double_t_get_allocator(self)
+        r"""get_allocator(map_string_double_T self) -> std::map< std::string,double >::allocator_type"""
+        return _libBornAgainParam.map_string_double_T_get_allocator(self)
 
     def count(self, x):
-        r"""count(map_string_double_t self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::size_type"""
-        return _libBornAgainParam.map_string_double_t_count(self, x)
+        r"""count(map_string_double_T self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::size_type"""
+        return _libBornAgainParam.map_string_double_T_count(self, x)
 
     def erase(self, *args):
         r"""
-        erase(map_string_double_t self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::size_type
-        erase(map_string_double_t self, std::map< std::string,double >::iterator position)
-        erase(map_string_double_t self, std::map< std::string,double >::iterator first, std::map< std::string,double >::iterator last)
+        erase(map_string_double_T self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::size_type
+        erase(map_string_double_T self, std::map< std::string,double >::iterator position)
+        erase(map_string_double_T self, std::map< std::string,double >::iterator first, std::map< std::string,double >::iterator last)
         """
-        return _libBornAgainParam.map_string_double_t_erase(self, *args)
+        return _libBornAgainParam.map_string_double_T_erase(self, *args)
 
     def find(self, x):
-        r"""find(map_string_double_t self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"""
-        return _libBornAgainParam.map_string_double_t_find(self, x)
+        r"""find(map_string_double_T self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"""
+        return _libBornAgainParam.map_string_double_T_find(self, x)
 
     def lower_bound(self, x):
-        r"""lower_bound(map_string_double_t self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"""
-        return _libBornAgainParam.map_string_double_t_lower_bound(self, x)
+        r"""lower_bound(map_string_double_T self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"""
+        return _libBornAgainParam.map_string_double_T_lower_bound(self, x)
 
     def upper_bound(self, x):
-        r"""upper_bound(map_string_double_t self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"""
-        return _libBornAgainParam.map_string_double_t_upper_bound(self, x)
-    __swig_destroy__ = _libBornAgainParam.delete_map_string_double_t
+        r"""upper_bound(map_string_double_T self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"""
+        return _libBornAgainParam.map_string_double_T_upper_bound(self, x)
+    __swig_destroy__ = _libBornAgainParam.delete_map_string_double_T
 
-# Register map_string_double_t in _libBornAgainParam:
-_libBornAgainParam.map_string_double_t_swigregister(map_string_double_t)
-class pvacuum_double_t(object):
+# Register map_string_double_T in _libBornAgainParam:
+_libBornAgainParam.map_string_double_T_swigregister(map_string_double_T)
+class pvacuum_double_T(object):
     r"""Proxy of C++ std::pair< double,double > class."""
 
     thisown = property(lambda x: x.this.own(), lambda x, v: x.this.own(v), doc="The membership flag")
@@ -1473,13 +1473,13 @@ class pvacuum_double_t(object):
 
     def __init__(self, *args):
         r"""
-        __init__(pvacuum_double_t self) -> pvacuum_double_t
-        __init__(pvacuum_double_t self, double first, double second) -> pvacuum_double_t
-        __init__(pvacuum_double_t self, pvacuum_double_t other) -> pvacuum_double_t
+        __init__(pvacuum_double_T self) -> pvacuum_double_T
+        __init__(pvacuum_double_T self, double first, double second) -> pvacuum_double_T
+        __init__(pvacuum_double_T self, pvacuum_double_T other) -> pvacuum_double_T
         """
-        _libBornAgainParam.pvacuum_double_t_swiginit(self, _libBornAgainParam.new_pvacuum_double_t(*args))
-    first = property(_libBornAgainParam.pvacuum_double_t_first_get, _libBornAgainParam.pvacuum_double_t_first_set, doc=r"""first : double""")
-    second = property(_libBornAgainParam.pvacuum_double_t_second_get, _libBornAgainParam.pvacuum_double_t_second_set, doc=r"""second : double""")
+        _libBornAgainParam.pvacuum_double_T_swiginit(self, _libBornAgainParam.new_pvacuum_double_T(*args))
+    first = property(_libBornAgainParam.pvacuum_double_T_first_get, _libBornAgainParam.pvacuum_double_T_first_set, doc=r"""first : double""")
+    second = property(_libBornAgainParam.pvacuum_double_T_second_get, _libBornAgainParam.pvacuum_double_T_second_set, doc=r"""second : double""")
     def __len__(self):
         return 2
     def __repr__(self):
@@ -1494,176 +1494,176 @@ class pvacuum_double_t(object):
             self.first = val
         else:
             self.second = val
-    __swig_destroy__ = _libBornAgainParam.delete_pvacuum_double_t
+    __swig_destroy__ = _libBornAgainParam.delete_pvacuum_double_T
 
-# Register pvacuum_double_t in _libBornAgainParam:
-_libBornAgainParam.pvacuum_double_t_swigregister(pvacuum_double_t)
-class vector_pvacuum_double_t(object):
+# Register pvacuum_double_T in _libBornAgainParam:
+_libBornAgainParam.pvacuum_double_T_swigregister(pvacuum_double_T)
+class vector_pvacuum_double_T(object):
     r"""Proxy of C++ std::vector< std::pair< double,double > > class."""
 
     thisown = property(lambda x: x.this.own(), lambda x, v: x.this.own(v), doc="The membership flag")
     __repr__ = _swig_repr
 
     def iterator(self):
-        r"""iterator(vector_pvacuum_double_t self) -> SwigPyIterator"""
-        return _libBornAgainParam.vector_pvacuum_double_t_iterator(self)
+        r"""iterator(vector_pvacuum_double_T self) -> SwigPyIterator"""
+        return _libBornAgainParam.vector_pvacuum_double_T_iterator(self)
     def __iter__(self):
         return self.iterator()
 
     def __nonzero__(self):
-        r"""__nonzero__(vector_pvacuum_double_t self) -> bool"""
-        return _libBornAgainParam.vector_pvacuum_double_t___nonzero__(self)
+        r"""__nonzero__(vector_pvacuum_double_T self) -> bool"""
+        return _libBornAgainParam.vector_pvacuum_double_T___nonzero__(self)
 
     def __bool__(self):
-        r"""__bool__(vector_pvacuum_double_t self) -> bool"""
-        return _libBornAgainParam.vector_pvacuum_double_t___bool__(self)
+        r"""__bool__(vector_pvacuum_double_T self) -> bool"""
+        return _libBornAgainParam.vector_pvacuum_double_T___bool__(self)
 
     def __len__(self):
-        r"""__len__(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::size_type"""
-        return _libBornAgainParam.vector_pvacuum_double_t___len__(self)
+        r"""__len__(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::size_type"""
+        return _libBornAgainParam.vector_pvacuum_double_T___len__(self)
 
     def __getslice__(self, i, j):
-        r"""__getslice__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j) -> vector_pvacuum_double_t"""
-        return _libBornAgainParam.vector_pvacuum_double_t___getslice__(self, i, j)
+        r"""__getslice__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j) -> vector_pvacuum_double_T"""
+        return _libBornAgainParam.vector_pvacuum_double_T___getslice__(self, i, j)
 
     def __setslice__(self, *args):
         r"""
-        __setslice__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j)
-        __setslice__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j, vector_pvacuum_double_t v)
+        __setslice__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j)
+        __setslice__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j, vector_pvacuum_double_T v)
         """
-        return _libBornAgainParam.vector_pvacuum_double_t___setslice__(self, *args)
+        return _libBornAgainParam.vector_pvacuum_double_T___setslice__(self, *args)
 
     def __delslice__(self, i, j):
-        r"""__delslice__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j)"""
-        return _libBornAgainParam.vector_pvacuum_double_t___delslice__(self, i, j)
+        r"""__delslice__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j)"""
+        return _libBornAgainParam.vector_pvacuum_double_T___delslice__(self, i, j)
 
     def __delitem__(self, *args):
         r"""
-        __delitem__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i)
-        __delitem__(vector_pvacuum_double_t self, SWIGPY_SLICEOBJECT * slice)
+        __delitem__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i)
+        __delitem__(vector_pvacuum_double_T self, SWIGPY_SLICEOBJECT * slice)
         """
-        return _libBornAgainParam.vector_pvacuum_double_t___delitem__(self, *args)
+        return _libBornAgainParam.vector_pvacuum_double_T___delitem__(self, *args)
 
     def __getitem__(self, *args):
         r"""
-        __getitem__(vector_pvacuum_double_t self, SWIGPY_SLICEOBJECT * slice) -> vector_pvacuum_double_t
-        __getitem__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i) -> pvacuum_double_t
+        __getitem__(vector_pvacuum_double_T self, SWIGPY_SLICEOBJECT * slice) -> vector_pvacuum_double_T
+        __getitem__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i) -> pvacuum_double_T
         """
-        return _libBornAgainParam.vector_pvacuum_double_t___getitem__(self, *args)
+        return _libBornAgainParam.vector_pvacuum_double_T___getitem__(self, *args)
 
     def __setitem__(self, *args):
         r"""
-        __setitem__(vector_pvacuum_double_t self, SWIGPY_SLICEOBJECT * slice, vector_pvacuum_double_t v)
-        __setitem__(vector_pvacuum_double_t self, SWIGPY_SLICEOBJECT * slice)
-        __setitem__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i, pvacuum_double_t x)
+        __setitem__(vector_pvacuum_double_T self, SWIGPY_SLICEOBJECT * slice, vector_pvacuum_double_T v)
+        __setitem__(vector_pvacuum_double_T self, SWIGPY_SLICEOBJECT * slice)
+        __setitem__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i, pvacuum_double_T x)
         """
-        return _libBornAgainParam.vector_pvacuum_double_t___setitem__(self, *args)
+        return _libBornAgainParam.vector_pvacuum_double_T___setitem__(self, *args)
 
     def pop(self):
-        r"""pop(vector_pvacuum_double_t self) -> pvacuum_double_t"""
-        return _libBornAgainParam.vector_pvacuum_double_t_pop(self)
+        r"""pop(vector_pvacuum_double_T self) -> pvacuum_double_T"""
+        return _libBornAgainParam.vector_pvacuum_double_T_pop(self)
 
     def append(self, x):
-        r"""append(vector_pvacuum_double_t self, pvacuum_double_t x)"""
-        return _libBornAgainParam.vector_pvacuum_double_t_append(self, x)
+        r"""append(vector_pvacuum_double_T self, pvacuum_double_T x)"""
+        return _libBornAgainParam.vector_pvacuum_double_T_append(self, x)
 
     def empty(self):
-        r"""empty(vector_pvacuum_double_t self) -> bool"""
-        return _libBornAgainParam.vector_pvacuum_double_t_empty(self)
+        r"""empty(vector_pvacuum_double_T self) -> bool"""
+        return _libBornAgainParam.vector_pvacuum_double_T_empty(self)
 
     def size(self):
-        r"""size(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::size_type"""
-        return _libBornAgainParam.vector_pvacuum_double_t_size(self)
+        r"""size(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::size_type"""
+        return _libBornAgainParam.vector_pvacuum_double_T_size(self)
 
     def swap(self, v):
-        r"""swap(vector_pvacuum_double_t self, vector_pvacuum_double_t v)"""
-        return _libBornAgainParam.vector_pvacuum_double_t_swap(self, v)
+        r"""swap(vector_pvacuum_double_T self, vector_pvacuum_double_T v)"""
+        return _libBornAgainParam.vector_pvacuum_double_T_swap(self, v)
 
     def begin(self):
-        r"""begin(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::iterator"""
-        return _libBornAgainParam.vector_pvacuum_double_t_begin(self)
+        r"""begin(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::iterator"""
+        return _libBornAgainParam.vector_pvacuum_double_T_begin(self)
 
     def end(self):
-        r"""end(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::iterator"""
-        return _libBornAgainParam.vector_pvacuum_double_t_end(self)
+        r"""end(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::iterator"""
+        return _libBornAgainParam.vector_pvacuum_double_T_end(self)
 
     def rbegin(self):
-        r"""rbegin(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::reverse_iterator"""
-        return _libBornAgainParam.vector_pvacuum_double_t_rbegin(self)
+        r"""rbegin(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::reverse_iterator"""
+        return _libBornAgainParam.vector_pvacuum_double_T_rbegin(self)
 
     def rend(self):
-        r"""rend(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::reverse_iterator"""
-        return _libBornAgainParam.vector_pvacuum_double_t_rend(self)
+        r"""rend(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::reverse_iterator"""
+        return _libBornAgainParam.vector_pvacuum_double_T_rend(self)
 
     def clear(self):
-        r"""clear(vector_pvacuum_double_t self)"""
-        return _libBornAgainParam.vector_pvacuum_double_t_clear(self)
+        r"""clear(vector_pvacuum_double_T self)"""
+        return _libBornAgainParam.vector_pvacuum_double_T_clear(self)
 
     def get_allocator(self):
-        r"""get_allocator(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::allocator_type"""
-        return _libBornAgainParam.vector_pvacuum_double_t_get_allocator(self)
+        r"""get_allocator(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::allocator_type"""
+        return _libBornAgainParam.vector_pvacuum_double_T_get_allocator(self)
 
     def pop_back(self):
-        r"""pop_back(vector_pvacuum_double_t self)"""
-        return _libBornAgainParam.vector_pvacuum_double_t_pop_back(self)
+        r"""pop_back(vector_pvacuum_double_T self)"""
+        return _libBornAgainParam.vector_pvacuum_double_T_pop_back(self)
 
     def erase(self, *args):
         r"""
-        erase(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::iterator pos) -> std::vector< std::pair< double,double > >::iterator
-        erase(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::iterator first, std::vector< std::pair< double,double > >::iterator last) -> std::vector< std::pair< double,double > >::iterator
+        erase(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::iterator pos) -> std::vector< std::pair< double,double > >::iterator
+        erase(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::iterator first, std::vector< std::pair< double,double > >::iterator last) -> std::vector< std::pair< double,double > >::iterator
         """
-        return _libBornAgainParam.vector_pvacuum_double_t_erase(self, *args)
+        return _libBornAgainParam.vector_pvacuum_double_T_erase(self, *args)
 
     def __init__(self, *args):
         r"""
-        __init__(vector_pvacuum_double_t self) -> vector_pvacuum_double_t
-        __init__(vector_pvacuum_double_t self, vector_pvacuum_double_t other) -> vector_pvacuum_double_t
-        __init__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::size_type size) -> vector_pvacuum_double_t
-        __init__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::size_type size, pvacuum_double_t value) -> vector_pvacuum_double_t
+        __init__(vector_pvacuum_double_T self) -> vector_pvacuum_double_T
+        __init__(vector_pvacuum_double_T self, vector_pvacuum_double_T other) -> vector_pvacuum_double_T
+        __init__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::size_type size) -> vector_pvacuum_double_T
+        __init__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::size_type size, pvacuum_double_T value) -> vector_pvacuum_double_T
         """
-        _libBornAgainParam.vector_pvacuum_double_t_swiginit(self, _libBornAgainParam.new_vector_pvacuum_double_t(*args))
+        _libBornAgainParam.vector_pvacuum_double_T_swiginit(self, _libBornAgainParam.new_vector_pvacuum_double_T(*args))
 
     def push_back(self, x):
-        r"""push_back(vector_pvacuum_double_t self, pvacuum_double_t x)"""
-        return _libBornAgainParam.vector_pvacuum_double_t_push_back(self, x)
+        r"""push_back(vector_pvacuum_double_T self, pvacuum_double_T x)"""
+        return _libBornAgainParam.vector_pvacuum_double_T_push_back(self, x)
 
     def front(self):
-        r"""front(vector_pvacuum_double_t self) -> pvacuum_double_t"""
-        return _libBornAgainParam.vector_pvacuum_double_t_front(self)
+        r"""front(vector_pvacuum_double_T self) -> pvacuum_double_T"""
+        return _libBornAgainParam.vector_pvacuum_double_T_front(self)
 
     def back(self):
-        r"""back(vector_pvacuum_double_t self) -> pvacuum_double_t"""
-        return _libBornAgainParam.vector_pvacuum_double_t_back(self)
+        r"""back(vector_pvacuum_double_T self) -> pvacuum_double_T"""
+        return _libBornAgainParam.vector_pvacuum_double_T_back(self)
 
     def assign(self, n, x):
-        r"""assign(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::size_type n, pvacuum_double_t x)"""
-        return _libBornAgainParam.vector_pvacuum_double_t_assign(self, n, x)
+        r"""assign(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::size_type n, pvacuum_double_T x)"""
+        return _libBornAgainParam.vector_pvacuum_double_T_assign(self, n, x)
 
     def resize(self, *args):
         r"""
-        resize(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::size_type new_size)
-        resize(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::size_type new_size, pvacuum_double_t x)
+        resize(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::size_type new_size)
+        resize(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::size_type new_size, pvacuum_double_T x)
         """
-        return _libBornAgainParam.vector_pvacuum_double_t_resize(self, *args)
+        return _libBornAgainParam.vector_pvacuum_double_T_resize(self, *args)
 
     def insert(self, *args):
         r"""
-        insert(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::iterator pos, pvacuum_double_t x) -> std::vector< std::pair< double,double > >::iterator
-        insert(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::iterator pos, std::vector< std::pair< double,double > >::size_type n, pvacuum_double_t x)
+        insert(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::iterator pos, pvacuum_double_T x) -> std::vector< std::pair< double,double > >::iterator
+        insert(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::iterator pos, std::vector< std::pair< double,double > >::size_type n, pvacuum_double_T x)
         """
-        return _libBornAgainParam.vector_pvacuum_double_t_insert(self, *args)
+        return _libBornAgainParam.vector_pvacuum_double_T_insert(self, *args)
 
     def reserve(self, n):
-        r"""reserve(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::size_type n)"""
-        return _libBornAgainParam.vector_pvacuum_double_t_reserve(self, n)
+        r"""reserve(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::size_type n)"""
+        return _libBornAgainParam.vector_pvacuum_double_T_reserve(self, n)
 
     def capacity(self):
-        r"""capacity(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::size_type"""
-        return _libBornAgainParam.vector_pvacuum_double_t_capacity(self)
-    __swig_destroy__ = _libBornAgainParam.delete_vector_pvacuum_double_t
+        r"""capacity(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::size_type"""
+        return _libBornAgainParam.vector_pvacuum_double_T_capacity(self)
+    __swig_destroy__ = _libBornAgainParam.delete_vector_pvacuum_double_T
 
-# Register vector_pvacuum_double_t in _libBornAgainParam:
-_libBornAgainParam.vector_pvacuum_double_t_swigregister(vector_pvacuum_double_t)
+# Register vector_pvacuum_double_T in _libBornAgainParam:
+_libBornAgainParam.vector_pvacuum_double_T_swigregister(vector_pvacuum_double_T)
 import libBornAgainBase
 class swig_dummy_type_const_inode_vector(object):
     r"""Proxy of C++ std::vector< INode const * > class."""
@@ -2024,7 +2024,7 @@ class INode(object):
     def __init__(self, *args):
         r"""
         __init__(INode self) -> INode
-        __init__(INode self, vdouble1d_t PValues) -> INode
+        __init__(INode self, vdouble1d_T PValues) -> INode
         """
         if self.__class__ == INode:
             _self = None
@@ -2050,7 +2050,7 @@ class INode(object):
         return _libBornAgainParam.INode_parDefs(self)
 
     def pars(self):
-        r"""pars(INode self) -> vdouble1d_t"""
+        r"""pars(INode self) -> vdouble1d_T"""
         return _libBornAgainParam.INode_pars(self)
 
     def nPars(self):
@@ -2126,7 +2126,7 @@ class DistributionGate(IDistribution1D):
 
     def __init__(self, *args):
         r"""
-        __init__(DistributionGate self, vdouble1d_t P, size_t n_samples) -> DistributionGate
+        __init__(DistributionGate self, vdouble1d_T P, size_t n_samples) -> DistributionGate
         __init__(DistributionGate self, double min, double max, size_t n_samples=25) -> DistributionGate
         """
         _libBornAgainParam.DistributionGate_swiginit(self, _libBornAgainParam.new_DistributionGate(*args))
@@ -2154,7 +2154,7 @@ class DistributionLorentz(IDistribution1D):
 
     def __init__(self, *args):
         r"""
-        __init__(DistributionLorentz self, vdouble1d_t P, size_t n_samples, double rel_sampling_width) -> DistributionLorentz
+        __init__(DistributionLorentz self, vdouble1d_T P, size_t n_samples, double rel_sampling_width) -> DistributionLorentz
         __init__(DistributionLorentz self, double mean, double hwhm, size_t n_samples=25, double rel_sampling_width=2.) -> DistributionLorentz
         """
         _libBornAgainParam.DistributionLorentz_swiginit(self, _libBornAgainParam.new_DistributionLorentz(*args))
@@ -2182,7 +2182,7 @@ class DistributionGaussian(IDistribution1D):
 
     def __init__(self, *args):
         r"""
-        __init__(DistributionGaussian self, vdouble1d_t P, size_t n_samples, double rel_sampling_width) -> DistributionGaussian
+        __init__(DistributionGaussian self, vdouble1d_T P, size_t n_samples, double rel_sampling_width) -> DistributionGaussian
         __init__(DistributionGaussian self, double mean, double std_dev, size_t n_samples=25, double rel_sampling_width=2.) -> DistributionGaussian
         """
         _libBornAgainParam.DistributionGaussian_swiginit(self, _libBornAgainParam.new_DistributionGaussian(*args))
@@ -2210,7 +2210,7 @@ class DistributionLogNormal(IDistribution1D):
 
     def __init__(self, *args):
         r"""
-        __init__(DistributionLogNormal self, vdouble1d_t P, size_t n_samples, double rel_sampling_width) -> DistributionLogNormal
+        __init__(DistributionLogNormal self, vdouble1d_T P, size_t n_samples, double rel_sampling_width) -> DistributionLogNormal
         __init__(DistributionLogNormal self, double median, double scale_param, size_t n_samples=25, double rel_sampling_width=2.) -> DistributionLogNormal
         """
         _libBornAgainParam.DistributionLogNormal_swiginit(self, _libBornAgainParam.new_DistributionLogNormal(*args))
@@ -2238,7 +2238,7 @@ class DistributionCosine(IDistribution1D):
 
     def __init__(self, *args):
         r"""
-        __init__(DistributionCosine self, vdouble1d_t P, size_t n_samples) -> DistributionCosine
+        __init__(DistributionCosine self, vdouble1d_T P, size_t n_samples) -> DistributionCosine
         __init__(DistributionCosine self, double mean, double sigma, size_t n_samples=25) -> DistributionCosine
         """
         _libBornAgainParam.DistributionCosine_swiginit(self, _libBornAgainParam.new_DistributionCosine(*args))
diff --git a/auto/Wrap/libBornAgainParam_wrap.cpp b/auto/Wrap/libBornAgainParam_wrap.cpp
index cc34176153d50c7f306bc705ecb7da072f94a028..0f09e97698771bceca83df6209a468c8ace98b03 100644
--- a/auto/Wrap/libBornAgainParam_wrap.cpp
+++ b/auto/Wrap/libBornAgainParam_wrap.cpp
@@ -8241,7 +8241,7 @@ SWIGINTERN PyObject *SwigPyIterator_swigregister(PyObject *SWIGUNUSEDPARM(self),
   return SWIG_Py_Void();
 }
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_iterator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_iterator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   PyObject **arg2 = (PyObject **) 0 ;
@@ -8256,7 +8256,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_iterator(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_iterator" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_iterator" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = (swig::SwigPyIterator *)std_vector_Sl_double_Sg__iterator(arg1,arg2);
@@ -8267,7 +8267,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___nonzero__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___nonzero__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -8280,7 +8280,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___nonzero__(PyObject *self, PyObject *arg
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___nonzero__" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___nonzero__" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = (bool)std_vector_Sl_double_Sg____nonzero__((std::vector< double > const *)arg1);
@@ -8291,7 +8291,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___bool__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___bool__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -8304,7 +8304,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___bool__(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___bool__" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___bool__" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = (bool)std_vector_Sl_double_Sg____bool__((std::vector< double > const *)arg1);
@@ -8315,7 +8315,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___len__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___len__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -8328,7 +8328,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___len__(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___len__" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___len__" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = std_vector_Sl_double_Sg____len__((std::vector< double > const *)arg1);
@@ -8339,7 +8339,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___getslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___getslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::difference_type arg2 ;
@@ -8354,20 +8354,20 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___getslice__(PyObject *self, PyObject *ar
   std::vector< double,std::allocator< double > > *result = 0 ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_t___getslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_T___getslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___getslice__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___getslice__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t___getslice__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T___getslice__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< double >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_t___getslice__" "', argument " "3"" of type '" "std::vector< double >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_T___getslice__" "', argument " "3"" of type '" "std::vector< double >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< double >::difference_type >(val3);
   try {
@@ -8384,7 +8384,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::difference_type arg2 ;
@@ -8400,17 +8400,17 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setslice____SWIG_0(PyObject *self, Py_s
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___setslice__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___setslice__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t___setslice__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T___setslice__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< double >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_t___setslice__" "', argument " "3"" of type '" "std::vector< double >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_T___setslice__" "', argument " "3"" of type '" "std::vector< double >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< double >::difference_type >(val3);
   try {
@@ -8427,7 +8427,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::difference_type arg2 ;
@@ -8445,27 +8445,27 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setslice____SWIG_1(PyObject *self, Py_s
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___setslice__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___setslice__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t___setslice__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T___setslice__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< double >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_t___setslice__" "', argument " "3"" of type '" "std::vector< double >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_T___setslice__" "', argument " "3"" of type '" "std::vector< double >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< double >::difference_type >(val3);
   {
     std::vector< double,std::allocator< double > > *ptr = (std::vector< double,std::allocator< double > > *)0;
     res4 = swig::asptr(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vdouble1d_t___setslice__" "', argument " "4"" of type '" "std::vector< double,std::allocator< double > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vdouble1d_T___setslice__" "', argument " "4"" of type '" "std::vector< double,std::allocator< double > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble1d_t___setslice__" "', argument " "4"" of type '" "std::vector< double,std::allocator< double > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble1d_T___setslice__" "', argument " "4"" of type '" "std::vector< double,std::allocator< double > > const &""'"); 
     }
     arg4 = ptr;
   }
@@ -8485,13 +8485,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___setslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___setslice__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_t___setslice__", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_T___setslice__", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -8508,7 +8508,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setslice__(PyObject *self, PyObject *ar
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vdouble1d_t___setslice____SWIG_0(self, argc, argv);
+          return _wrap_vdouble1d_T___setslice____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -8531,7 +8531,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setslice__(PyObject *self, PyObject *ar
           int res = swig::asptr(argv[3], (std::vector< double,std::allocator< double > >**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vdouble1d_t___setslice____SWIG_1(self, argc, argv);
+            return _wrap_vdouble1d_T___setslice____SWIG_1(self, argc, argv);
           }
         }
       }
@@ -8539,7 +8539,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setslice__(PyObject *self, PyObject *ar
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_t___setslice__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_T___setslice__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< double >::__setslice__(std::vector< double >::difference_type,std::vector< double >::difference_type)\n"
     "    std::vector< double >::__setslice__(std::vector< double >::difference_type,std::vector< double >::difference_type,std::vector< double,std::allocator< double > > const &)\n");
@@ -8547,7 +8547,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___delslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___delslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::difference_type arg2 ;
@@ -8561,20 +8561,20 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___delslice__(PyObject *self, PyObject *ar
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_t___delslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_T___delslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___delslice__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___delslice__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t___delslice__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T___delslice__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< double >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_t___delslice__" "', argument " "3"" of type '" "std::vector< double >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_T___delslice__" "', argument " "3"" of type '" "std::vector< double >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< double >::difference_type >(val3);
   try {
@@ -8591,7 +8591,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::difference_type arg2 ;
@@ -8604,12 +8604,12 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___delitem____SWIG_0(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___delitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___delitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t___delitem__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T___delitem__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< double >::difference_type >(val2);
   try {
@@ -8626,7 +8626,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -8638,12 +8638,12 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___getitem____SWIG_0(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___getitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___getitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -8661,7 +8661,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -8674,12 +8674,12 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setitem____SWIG_0(PyObject *self, Py_ss
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___setitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___setitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -8687,10 +8687,10 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setitem____SWIG_0(PyObject *self, Py_ss
     std::vector< double,std::allocator< double > > *ptr = (std::vector< double,std::allocator< double > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble1d_t___setitem__" "', argument " "3"" of type '" "std::vector< double,std::allocator< double > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble1d_T___setitem__" "', argument " "3"" of type '" "std::vector< double,std::allocator< double > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble1d_t___setitem__" "', argument " "3"" of type '" "std::vector< double,std::allocator< double > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble1d_T___setitem__" "', argument " "3"" of type '" "std::vector< double,std::allocator< double > > const &""'"); 
     }
     arg3 = ptr;
   }
@@ -8710,7 +8710,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -8721,12 +8721,12 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setitem____SWIG_1(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___setitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___setitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -8744,7 +8744,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -8755,12 +8755,12 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___delitem____SWIG_1(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___delitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___delitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -8778,13 +8778,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___delitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___delitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_t___delitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_T___delitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -8795,7 +8795,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___delitem__(PyObject *self, PyObject *arg
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vdouble1d_t___delitem____SWIG_1(self, argc, argv);
+        return _wrap_vdouble1d_T___delitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -8809,13 +8809,13 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___delitem__(PyObject *self, PyObject *arg
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vdouble1d_t___delitem____SWIG_0(self, argc, argv);
+        return _wrap_vdouble1d_T___delitem____SWIG_0(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_t___delitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_T___delitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< double >::__delitem__(std::vector< double >::difference_type)\n"
     "    std::vector< double >::__delitem__(SWIGPY_SLICEOBJECT *)\n");
@@ -8823,7 +8823,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::difference_type arg2 ;
@@ -8837,12 +8837,12 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___getitem____SWIG_1(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___getitem__" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___getitem__" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t___getitem__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T___getitem__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< double >::difference_type >(val2);
   try {
@@ -8858,13 +8858,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___getitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___getitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_t___getitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_T___getitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -8875,7 +8875,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___getitem__(PyObject *self, PyObject *arg
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vdouble1d_t___getitem____SWIG_0(self, argc, argv);
+        return _wrap_vdouble1d_T___getitem____SWIG_0(self, argc, argv);
       }
     }
   }
@@ -8889,13 +8889,13 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___getitem__(PyObject *self, PyObject *arg
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vdouble1d_t___getitem____SWIG_1(self, argc, argv);
+        return _wrap_vdouble1d_T___getitem____SWIG_1(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_t___getitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_T___getitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< double >::__getitem__(SWIGPY_SLICEOBJECT *)\n"
     "    std::vector< double >::__getitem__(std::vector< double >::difference_type) const\n");
@@ -8903,7 +8903,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::difference_type arg2 ;
@@ -8920,17 +8920,17 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setitem____SWIG_2(PyObject *self, Py_ss
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___setitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___setitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t___setitem__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T___setitem__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< double >::difference_type >(val2);
   ecode3 = SWIG_AsVal_double(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_t___setitem__" "', argument " "3"" of type '" "std::vector< double >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_T___setitem__" "', argument " "3"" of type '" "std::vector< double >::value_type""'");
   } 
   temp3 = static_cast< std::vector< double >::value_type >(val3);
   arg3 = &temp3;
@@ -8946,13 +8946,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___setitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___setitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_t___setitem__", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_T___setitem__", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -8963,7 +8963,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setitem__(PyObject *self, PyObject *arg
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vdouble1d_t___setitem____SWIG_1(self, argc, argv);
+        return _wrap_vdouble1d_T___setitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -8979,7 +8979,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setitem__(PyObject *self, PyObject *arg
         int res = swig::asptr(argv[2], (std::vector< double,std::allocator< double > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vdouble1d_t___setitem____SWIG_0(self, argc, argv);
+          return _wrap_vdouble1d_T___setitem____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -8999,14 +8999,14 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setitem__(PyObject *self, PyObject *arg
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vdouble1d_t___setitem____SWIG_2(self, argc, argv);
+          return _wrap_vdouble1d_T___setitem____SWIG_2(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_t___setitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_T___setitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< double >::__setitem__(SWIGPY_SLICEOBJECT *,std::vector< double,std::allocator< double > > const &)\n"
     "    std::vector< double >::__setitem__(SWIGPY_SLICEOBJECT *)\n"
@@ -9015,7 +9015,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_pop(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_pop(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -9028,7 +9028,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_pop(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_pop" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_pop" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   try {
@@ -9043,7 +9043,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_append(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_append(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::value_type *arg2 = 0 ;
@@ -9055,15 +9055,15 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_append(PyObject *self, PyObject *args) {
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_t_append", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_T_append", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_append" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_append" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_double(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t_append" "', argument " "2"" of type '" "std::vector< double >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T_append" "', argument " "2"" of type '" "std::vector< double >::value_type""'");
   } 
   temp2 = static_cast< std::vector< double >::value_type >(val2);
   arg2 = &temp2;
@@ -9075,7 +9075,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vdouble1d_t__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
+SWIGINTERN PyObject *_wrap_new_vdouble1d_T__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
   PyObject *resultobj = 0;
   std::vector< double > *result = 0 ;
   
@@ -9089,7 +9089,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vdouble1d_t__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vdouble1d_T__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = 0 ;
   int res1 = SWIG_OLDOBJ ;
@@ -9101,10 +9101,10 @@ SWIGINTERN PyObject *_wrap_new_vdouble1d_t__SWIG_1(PyObject *self, Py_ssize_t no
     std::vector< double,std::allocator< double > > *ptr = (std::vector< double,std::allocator< double > > *)0;
     res1 = swig::asptr(swig_obj[0], &ptr);
     if (!SWIG_IsOK(res1)) {
-      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vdouble1d_t" "', argument " "1"" of type '" "std::vector< double > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vdouble1d_T" "', argument " "1"" of type '" "std::vector< double > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vdouble1d_t" "', argument " "1"" of type '" "std::vector< double > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vdouble1d_T" "', argument " "1"" of type '" "std::vector< double > const &""'"); 
     }
     arg1 = ptr;
   }
@@ -9118,7 +9118,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_empty(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_empty(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -9131,7 +9131,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_empty(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_empty" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_empty" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = (bool)((std::vector< double > const *)arg1)->empty();
@@ -9142,7 +9142,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_size(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_size(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -9155,7 +9155,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_size(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_size" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_size" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = ((std::vector< double > const *)arg1)->size();
@@ -9166,7 +9166,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_swap(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_swap(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double > *arg2 = 0 ;
@@ -9177,18 +9177,18 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_swap(PyObject *self, PyObject *args) {
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_t_swap", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_T_swap", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_swap" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_swap" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], &argp2, SWIGTYPE_p_std__vectorT_double_t,  0 );
   if (!SWIG_IsOK(res2)) {
-    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vdouble1d_t_swap" "', argument " "2"" of type '" "std::vector< double > &""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vdouble1d_T_swap" "', argument " "2"" of type '" "std::vector< double > &""'"); 
   }
   if (!argp2) {
-    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble1d_t_swap" "', argument " "2"" of type '" "std::vector< double > &""'"); 
+    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble1d_T_swap" "', argument " "2"" of type '" "std::vector< double > &""'"); 
   }
   arg2 = reinterpret_cast< std::vector< double > * >(argp2);
   (arg1)->swap(*arg2);
@@ -9199,7 +9199,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_begin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_begin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -9212,7 +9212,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_begin(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_begin" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_begin" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = (arg1)->begin();
@@ -9224,7 +9224,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_end(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_end(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -9237,7 +9237,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_end(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_end" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_end" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = (arg1)->end();
@@ -9249,7 +9249,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_rbegin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_rbegin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -9262,7 +9262,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_rbegin(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_rbegin" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_rbegin" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = (arg1)->rbegin();
@@ -9274,7 +9274,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_rend(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_rend(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -9287,7 +9287,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_rend(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_rend" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_rend" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = (arg1)->rend();
@@ -9299,7 +9299,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_clear(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_clear(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -9311,7 +9311,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_clear(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_clear" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_clear" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   (arg1)->clear();
@@ -9322,7 +9322,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_get_allocator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_get_allocator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -9335,7 +9335,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_get_allocator(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_get_allocator" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_get_allocator" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = ((std::vector< double > const *)arg1)->get_allocator();
@@ -9346,7 +9346,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vdouble1d_t__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vdouble1d_T__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double >::size_type arg1 ;
   size_t val1 ;
@@ -9357,7 +9357,7 @@ SWIGINTERN PyObject *_wrap_new_vdouble1d_t__SWIG_2(PyObject *self, Py_ssize_t no
   if ((nobjs < 1) || (nobjs > 1)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vdouble1d_t" "', argument " "1"" of type '" "std::vector< double >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vdouble1d_T" "', argument " "1"" of type '" "std::vector< double >::size_type""'");
   } 
   arg1 = static_cast< std::vector< double >::size_type >(val1);
   result = (std::vector< double > *)new std::vector< double >(arg1);
@@ -9368,7 +9368,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_pop_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_pop_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -9380,7 +9380,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_pop_back(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_pop_back" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_pop_back" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   (arg1)->pop_back();
@@ -9391,7 +9391,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::size_type arg2 ;
@@ -9404,12 +9404,12 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_resize__SWIG_0(PyObject *self, Py_ssize_t
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_resize" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_resize" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t_resize" "', argument " "2"" of type '" "std::vector< double >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T_resize" "', argument " "2"" of type '" "std::vector< double >::size_type""'");
   } 
   arg2 = static_cast< std::vector< double >::size_type >(val2);
   (arg1)->resize(arg2);
@@ -9420,7 +9420,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::iterator arg2 ;
@@ -9434,18 +9434,18 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_erase__SWIG_0(PyObject *self, Py_ssize_t
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_erase" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_erase" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t_erase" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T_erase" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< double >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< double >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t_erase" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T_erase" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
     }
   }
   result = std_vector_Sl_double_Sg__erase__SWIG_0(arg1,SWIG_STD_MOVE(arg2));
@@ -9457,7 +9457,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::iterator arg2 ;
@@ -9474,29 +9474,29 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_erase__SWIG_1(PyObject *self, Py_ssize_t
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_erase" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_erase" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t_erase" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T_erase" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< double >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< double >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t_erase" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T_erase" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
     }
   }
   res3 = SWIG_ConvertPtr(swig_obj[2], SWIG_as_voidptrptr(&iter3), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res3) || !iter3) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t_erase" "', argument " "3"" of type '" "std::vector< double >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T_erase" "', argument " "3"" of type '" "std::vector< double >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< double >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< double >::iterator > *>(iter3);
     if (iter_t) {
       arg3 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t_erase" "', argument " "3"" of type '" "std::vector< double >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T_erase" "', argument " "3"" of type '" "std::vector< double >::iterator""'");
     }
   }
   result = std_vector_Sl_double_Sg__erase__SWIG_1(arg1,SWIG_STD_MOVE(arg2),SWIG_STD_MOVE(arg3));
@@ -9508,13 +9508,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_erase(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_erase(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_t_erase", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_T_erase", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -9525,7 +9525,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_erase(PyObject *self, PyObject *args) {
       int res = SWIG_ConvertPtr(argv[1], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
       _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< double >::iterator > *>(iter) != 0));
       if (_v) {
-        return _wrap_vdouble1d_t_erase__SWIG_0(self, argc, argv);
+        return _wrap_vdouble1d_T_erase__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -9542,14 +9542,14 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_erase(PyObject *self, PyObject *args) {
         int res = SWIG_ConvertPtr(argv[2], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
         _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< double >::iterator > *>(iter) != 0));
         if (_v) {
-          return _wrap_vdouble1d_t_erase__SWIG_1(self, argc, argv);
+          return _wrap_vdouble1d_T_erase__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_t_erase'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_T_erase'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< double >::erase(std::vector< double >::iterator)\n"
     "    std::vector< double >::erase(std::vector< double >::iterator,std::vector< double >::iterator)\n");
@@ -9557,7 +9557,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vdouble1d_t__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vdouble1d_T__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double >::size_type arg1 ;
   std::vector< double >::value_type *arg2 = 0 ;
@@ -9572,12 +9572,12 @@ SWIGINTERN PyObject *_wrap_new_vdouble1d_t__SWIG_3(PyObject *self, Py_ssize_t no
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vdouble1d_t" "', argument " "1"" of type '" "std::vector< double >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vdouble1d_T" "', argument " "1"" of type '" "std::vector< double >::size_type""'");
   } 
   arg1 = static_cast< std::vector< double >::size_type >(val1);
   ecode2 = SWIG_AsVal_double(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "new_vdouble1d_t" "', argument " "2"" of type '" "std::vector< double >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "new_vdouble1d_T" "', argument " "2"" of type '" "std::vector< double >::value_type""'");
   } 
   temp2 = static_cast< std::vector< double >::value_type >(val2);
   arg2 = &temp2;
@@ -9589,16 +9589,16 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vdouble1d_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_new_vdouble1d_T(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vdouble1d_t", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vdouble1d_T", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 0) {
-    return _wrap_new_vdouble1d_t__SWIG_0(self, argc, argv);
+    return _wrap_new_vdouble1d_T__SWIG_0(self, argc, argv);
   }
   if (argc == 1) {
     int _v = 0;
@@ -9607,7 +9607,7 @@ SWIGINTERN PyObject *_wrap_new_vdouble1d_t(PyObject *self, PyObject *args) {
       _v = SWIG_CheckState(res);
     }
     if (_v) {
-      return _wrap_new_vdouble1d_t__SWIG_2(self, argc, argv);
+      return _wrap_new_vdouble1d_T__SWIG_2(self, argc, argv);
     }
   }
   if (argc == 1) {
@@ -9615,7 +9615,7 @@ SWIGINTERN PyObject *_wrap_new_vdouble1d_t(PyObject *self, PyObject *args) {
     int res = swig::asptr(argv[0], (std::vector< double,std::allocator< double > >**)(0));
     _v = SWIG_CheckState(res);
     if (_v) {
-      return _wrap_new_vdouble1d_t__SWIG_1(self, argc, argv);
+      return _wrap_new_vdouble1d_T__SWIG_1(self, argc, argv);
     }
   }
   if (argc == 2) {
@@ -9630,13 +9630,13 @@ SWIGINTERN PyObject *_wrap_new_vdouble1d_t(PyObject *self, PyObject *args) {
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_new_vdouble1d_t__SWIG_3(self, argc, argv);
+        return _wrap_new_vdouble1d_T__SWIG_3(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vdouble1d_t'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vdouble1d_T'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< double >::vector()\n"
     "    std::vector< double >::vector(std::vector< double > const &)\n"
@@ -9646,7 +9646,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_push_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_push_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::value_type *arg2 = 0 ;
@@ -9658,15 +9658,15 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_push_back(PyObject *self, PyObject *args)
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_t_push_back", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_T_push_back", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_push_back" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_push_back" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_double(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t_push_back" "', argument " "2"" of type '" "std::vector< double >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T_push_back" "', argument " "2"" of type '" "std::vector< double >::value_type""'");
   } 
   temp2 = static_cast< std::vector< double >::value_type >(val2);
   arg2 = &temp2;
@@ -9678,7 +9678,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_front(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_front(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -9691,7 +9691,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_front(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_front" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_front" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = (std::vector< double >::value_type *) &((std::vector< double > const *)arg1)->front();
@@ -9703,7 +9703,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -9716,7 +9716,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_back(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_back" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_back" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = (std::vector< double >::value_type *) &((std::vector< double > const *)arg1)->back();
@@ -9728,7 +9728,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_assign(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_assign(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::size_type arg2 ;
@@ -9743,20 +9743,20 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_assign(PyObject *self, PyObject *args) {
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_t_assign", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_T_assign", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_assign" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_assign" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t_assign" "', argument " "2"" of type '" "std::vector< double >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T_assign" "', argument " "2"" of type '" "std::vector< double >::size_type""'");
   } 
   arg2 = static_cast< std::vector< double >::size_type >(val2);
   ecode3 = SWIG_AsVal_double(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_t_assign" "', argument " "3"" of type '" "std::vector< double >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_T_assign" "', argument " "3"" of type '" "std::vector< double >::value_type""'");
   } 
   temp3 = static_cast< std::vector< double >::value_type >(val3);
   arg3 = &temp3;
@@ -9768,7 +9768,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::size_type arg2 ;
@@ -9785,17 +9785,17 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_resize__SWIG_1(PyObject *self, Py_ssize_t
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_resize" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_resize" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t_resize" "', argument " "2"" of type '" "std::vector< double >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T_resize" "', argument " "2"" of type '" "std::vector< double >::size_type""'");
   } 
   arg2 = static_cast< std::vector< double >::size_type >(val2);
   ecode3 = SWIG_AsVal_double(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_t_resize" "', argument " "3"" of type '" "std::vector< double >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_T_resize" "', argument " "3"" of type '" "std::vector< double >::value_type""'");
   } 
   temp3 = static_cast< std::vector< double >::value_type >(val3);
   arg3 = &temp3;
@@ -9807,13 +9807,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_resize(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_resize(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_t_resize", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_T_resize", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -9825,7 +9825,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_resize(PyObject *self, PyObject *args) {
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vdouble1d_t_resize__SWIG_0(self, argc, argv);
+        return _wrap_vdouble1d_T_resize__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -9844,14 +9844,14 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_resize(PyObject *self, PyObject *args) {
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vdouble1d_t_resize__SWIG_1(self, argc, argv);
+          return _wrap_vdouble1d_T_resize__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_t_resize'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_T_resize'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< double >::resize(std::vector< double >::size_type)\n"
     "    std::vector< double >::resize(std::vector< double >::size_type,std::vector< double >::value_type const &)\n");
@@ -9859,7 +9859,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::iterator arg2 ;
@@ -9877,23 +9877,23 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_insert__SWIG_0(PyObject *self, Py_ssize_t
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_insert" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_insert" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t_insert" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T_insert" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< double >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< double >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t_insert" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T_insert" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_double(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_t_insert" "', argument " "3"" of type '" "std::vector< double >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_T_insert" "', argument " "3"" of type '" "std::vector< double >::value_type""'");
   } 
   temp3 = static_cast< std::vector< double >::value_type >(val3);
   arg3 = &temp3;
@@ -9906,7 +9906,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::iterator arg2 ;
@@ -9926,28 +9926,28 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_insert__SWIG_1(PyObject *self, Py_ssize_t
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_insert" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_insert" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t_insert" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T_insert" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< double >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< double >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t_insert" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T_insert" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_size_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_t_insert" "', argument " "3"" of type '" "std::vector< double >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_T_insert" "', argument " "3"" of type '" "std::vector< double >::size_type""'");
   } 
   arg3 = static_cast< std::vector< double >::size_type >(val3);
   ecode4 = SWIG_AsVal_double(swig_obj[3], &val4);
   if (!SWIG_IsOK(ecode4)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode4), "in method '" "vdouble1d_t_insert" "', argument " "4"" of type '" "std::vector< double >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode4), "in method '" "vdouble1d_T_insert" "', argument " "4"" of type '" "std::vector< double >::value_type""'");
   } 
   temp4 = static_cast< std::vector< double >::value_type >(val4);
   arg4 = &temp4;
@@ -9959,13 +9959,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_insert(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_insert(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_t_insert", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_T_insert", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -9981,7 +9981,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_insert(PyObject *self, PyObject *args) {
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vdouble1d_t_insert__SWIG_0(self, argc, argv);
+          return _wrap_vdouble1d_T_insert__SWIG_0(self, argc, argv);
         }
       }
     }
@@ -10005,7 +10005,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_insert(PyObject *self, PyObject *args) {
             _v = SWIG_CheckState(res);
           }
           if (_v) {
-            return _wrap_vdouble1d_t_insert__SWIG_1(self, argc, argv);
+            return _wrap_vdouble1d_T_insert__SWIG_1(self, argc, argv);
           }
         }
       }
@@ -10013,7 +10013,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_insert(PyObject *self, PyObject *args) {
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_t_insert'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_T_insert'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< double >::insert(std::vector< double >::iterator,std::vector< double >::value_type const &)\n"
     "    std::vector< double >::insert(std::vector< double >::iterator,std::vector< double >::size_type,std::vector< double >::value_type const &)\n");
@@ -10021,7 +10021,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_reserve(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_reserve(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::size_type arg2 ;
@@ -10032,15 +10032,15 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_reserve(PyObject *self, PyObject *args) {
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_t_reserve", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_T_reserve", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_reserve" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_reserve" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t_reserve" "', argument " "2"" of type '" "std::vector< double >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T_reserve" "', argument " "2"" of type '" "std::vector< double >::size_type""'");
   } 
   arg2 = static_cast< std::vector< double >::size_type >(val2);
   (arg1)->reserve(arg2);
@@ -10051,7 +10051,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_capacity(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_capacity(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -10064,7 +10064,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_capacity(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_capacity" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_capacity" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = ((std::vector< double > const *)arg1)->capacity();
@@ -10075,7 +10075,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_delete_vdouble1d_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_delete_vdouble1d_T(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -10087,7 +10087,7 @@ SWIGINTERN PyObject *_wrap_delete_vdouble1d_t(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, SWIG_POINTER_DISOWN |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vdouble1d_t" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vdouble1d_T" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   {
@@ -10108,18 +10108,18 @@ fail:
 }
 
 
-SWIGINTERN PyObject *vdouble1d_t_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vdouble1d_T_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   PyObject *obj;
   if (!SWIG_Python_UnpackTuple(args, "swigregister", 1, 1, &obj)) return NULL;
   SWIG_TypeNewClientData(SWIGTYPE_p_std__vectorT_double_t, SWIG_NewClientData(obj));
   return SWIG_Py_Void();
 }
 
-SWIGINTERN PyObject *vdouble1d_t_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vdouble1d_T_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   return SWIG_Python_InitShadowInstance(args);
 }
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_iterator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_iterator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   PyObject **arg2 = (PyObject **) 0 ;
@@ -10134,7 +10134,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_iterator(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_iterator" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_iterator" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = (swig::SwigPyIterator *)std_vector_Sl_std_vector_Sl_double_Sg__Sg__iterator(arg1,arg2);
@@ -10145,7 +10145,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___nonzero__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___nonzero__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -10158,7 +10158,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___nonzero__(PyObject *self, PyObject *arg
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___nonzero__" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___nonzero__" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = (bool)std_vector_Sl_std_vector_Sl_double_Sg__Sg____nonzero__((std::vector< std::vector< double > > const *)arg1);
@@ -10169,7 +10169,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___bool__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___bool__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -10182,7 +10182,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___bool__(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___bool__" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___bool__" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = (bool)std_vector_Sl_std_vector_Sl_double_Sg__Sg____bool__((std::vector< std::vector< double > > const *)arg1);
@@ -10193,7 +10193,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___len__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___len__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -10206,7 +10206,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___len__(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___len__" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___len__" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = std_vector_Sl_std_vector_Sl_double_Sg__Sg____len__((std::vector< std::vector< double > > const *)arg1);
@@ -10217,7 +10217,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___getslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___getslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::difference_type arg2 ;
@@ -10232,20 +10232,20 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___getslice__(PyObject *self, PyObject *ar
   std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > *result = 0 ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_t___getslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_T___getslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___getslice__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___getslice__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_t___getslice__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_T___getslice__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble2d_t___getslice__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble2d_T___getslice__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::vector< double > >::difference_type >(val3);
   try {
@@ -10262,7 +10262,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::difference_type arg2 ;
@@ -10278,17 +10278,17 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setslice____SWIG_0(PyObject *self, Py_s
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___setslice__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___setslice__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_t___setslice__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_T___setslice__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble2d_t___setslice__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble2d_T___setslice__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::vector< double > >::difference_type >(val3);
   try {
@@ -10305,7 +10305,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::difference_type arg2 ;
@@ -10323,27 +10323,27 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setslice____SWIG_1(PyObject *self, Py_s
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___setslice__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___setslice__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_t___setslice__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_T___setslice__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble2d_t___setslice__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble2d_T___setslice__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::vector< double > >::difference_type >(val3);
   {
     std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > *ptr = (std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > *)0;
     res4 = swig::asptr(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vdouble2d_t___setslice__" "', argument " "4"" of type '" "std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vdouble2d_T___setslice__" "', argument " "4"" of type '" "std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_t___setslice__" "', argument " "4"" of type '" "std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_T___setslice__" "', argument " "4"" of type '" "std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > const &""'"); 
     }
     arg4 = ptr;
   }
@@ -10363,13 +10363,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___setslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___setslice__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_t___setslice__", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_T___setslice__", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -10386,7 +10386,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setslice__(PyObject *self, PyObject *ar
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vdouble2d_t___setslice____SWIG_0(self, argc, argv);
+          return _wrap_vdouble2d_T___setslice____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -10409,7 +10409,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setslice__(PyObject *self, PyObject *ar
           int res = swig::asptr(argv[3], (std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > >**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vdouble2d_t___setslice____SWIG_1(self, argc, argv);
+            return _wrap_vdouble2d_T___setslice____SWIG_1(self, argc, argv);
           }
         }
       }
@@ -10417,7 +10417,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setslice__(PyObject *self, PyObject *ar
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_t___setslice__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_T___setslice__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< double > >::__setslice__(std::vector< std::vector< double > >::difference_type,std::vector< std::vector< double > >::difference_type)\n"
     "    std::vector< std::vector< double > >::__setslice__(std::vector< std::vector< double > >::difference_type,std::vector< std::vector< double > >::difference_type,std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > const &)\n");
@@ -10425,7 +10425,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___delslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___delslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::difference_type arg2 ;
@@ -10439,20 +10439,20 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___delslice__(PyObject *self, PyObject *ar
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_t___delslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_T___delslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___delslice__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___delslice__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_t___delslice__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_T___delslice__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble2d_t___delslice__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble2d_T___delslice__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::vector< double > >::difference_type >(val3);
   try {
@@ -10469,7 +10469,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::difference_type arg2 ;
@@ -10482,12 +10482,12 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___delitem____SWIG_0(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___delitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___delitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_t___delitem__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_T___delitem__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< double > >::difference_type >(val2);
   try {
@@ -10504,7 +10504,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -10516,12 +10516,12 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___getitem____SWIG_0(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___getitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___getitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -10539,7 +10539,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -10552,12 +10552,12 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setitem____SWIG_0(PyObject *self, Py_ss
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -10565,10 +10565,10 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setitem____SWIG_0(PyObject *self, Py_ss
     std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > *ptr = (std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble2d_t___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble2d_T___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_t___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_T___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > const &""'"); 
     }
     arg3 = ptr;
   }
@@ -10588,7 +10588,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -10599,12 +10599,12 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setitem____SWIG_1(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -10622,7 +10622,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -10633,12 +10633,12 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___delitem____SWIG_1(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___delitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___delitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -10656,13 +10656,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___delitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___delitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_t___delitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_T___delitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -10673,7 +10673,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___delitem__(PyObject *self, PyObject *arg
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vdouble2d_t___delitem____SWIG_1(self, argc, argv);
+        return _wrap_vdouble2d_T___delitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -10687,13 +10687,13 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___delitem__(PyObject *self, PyObject *arg
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vdouble2d_t___delitem____SWIG_0(self, argc, argv);
+        return _wrap_vdouble2d_T___delitem____SWIG_0(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_t___delitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_T___delitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< double > >::__delitem__(std::vector< std::vector< double > >::difference_type)\n"
     "    std::vector< std::vector< double > >::__delitem__(SWIGPY_SLICEOBJECT *)\n");
@@ -10701,7 +10701,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::difference_type arg2 ;
@@ -10715,12 +10715,12 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___getitem____SWIG_1(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___getitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___getitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_t___getitem__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_T___getitem__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< double > >::difference_type >(val2);
   try {
@@ -10736,13 +10736,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___getitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___getitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_t___getitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_T___getitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -10753,7 +10753,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___getitem__(PyObject *self, PyObject *arg
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vdouble2d_t___getitem____SWIG_0(self, argc, argv);
+        return _wrap_vdouble2d_T___getitem____SWIG_0(self, argc, argv);
       }
     }
   }
@@ -10767,13 +10767,13 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___getitem__(PyObject *self, PyObject *arg
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vdouble2d_t___getitem____SWIG_1(self, argc, argv);
+        return _wrap_vdouble2d_T___getitem____SWIG_1(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_t___getitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_T___getitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< double > >::__getitem__(SWIGPY_SLICEOBJECT *)\n"
     "    std::vector< std::vector< double > >::__getitem__(std::vector< std::vector< double > >::difference_type) const\n");
@@ -10781,7 +10781,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::difference_type arg2 ;
@@ -10796,22 +10796,22 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setitem____SWIG_2(PyObject *self, Py_ss
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_t___setitem__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_T___setitem__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< double > >::difference_type >(val2);
   {
     std::vector< double,std::allocator< double > > *ptr = (std::vector< double,std::allocator< double > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble2d_t___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble2d_T___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_t___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_T___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -10829,13 +10829,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___setitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___setitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_t___setitem__", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_T___setitem__", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -10846,7 +10846,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setitem__(PyObject *self, PyObject *arg
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vdouble2d_t___setitem____SWIG_1(self, argc, argv);
+        return _wrap_vdouble2d_T___setitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -10862,7 +10862,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setitem__(PyObject *self, PyObject *arg
         int res = swig::asptr(argv[2], (std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vdouble2d_t___setitem____SWIG_0(self, argc, argv);
+          return _wrap_vdouble2d_T___setitem____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -10880,14 +10880,14 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setitem__(PyObject *self, PyObject *arg
         int res = swig::asptr(argv[2], (std::vector< double,std::allocator< double > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vdouble2d_t___setitem____SWIG_2(self, argc, argv);
+          return _wrap_vdouble2d_T___setitem____SWIG_2(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_t___setitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_T___setitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< double > >::__setitem__(SWIGPY_SLICEOBJECT *,std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > const &)\n"
     "    std::vector< std::vector< double > >::__setitem__(SWIGPY_SLICEOBJECT *)\n"
@@ -10896,7 +10896,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_pop(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_pop(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -10909,7 +10909,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_pop(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_pop" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_pop" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   try {
@@ -10924,7 +10924,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_append(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_append(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::value_type *arg2 = 0 ;
@@ -10934,20 +10934,20 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_append(PyObject *self, PyObject *args) {
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_t_append", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_T_append", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_append" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_append" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   {
     std::vector< double,std::allocator< double > > *ptr = (std::vector< double,std::allocator< double > > *)0;
     res2 = swig::asptr(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vdouble2d_t_append" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vdouble2d_T_append" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_t_append" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_T_append" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -10961,7 +10961,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vdouble2d_t__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
+SWIGINTERN PyObject *_wrap_new_vdouble2d_T__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *result = 0 ;
   
@@ -10975,7 +10975,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vdouble2d_t__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vdouble2d_T__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double,std::allocator< double > > > *arg1 = 0 ;
   int res1 = SWIG_OLDOBJ ;
@@ -10987,10 +10987,10 @@ SWIGINTERN PyObject *_wrap_new_vdouble2d_t__SWIG_1(PyObject *self, Py_ssize_t no
     std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > *ptr = (std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > *)0;
     res1 = swig::asptr(swig_obj[0], &ptr);
     if (!SWIG_IsOK(res1)) {
-      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vdouble2d_t" "', argument " "1"" of type '" "std::vector< std::vector< double,std::allocator< double > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vdouble2d_T" "', argument " "1"" of type '" "std::vector< std::vector< double,std::allocator< double > > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vdouble2d_t" "', argument " "1"" of type '" "std::vector< std::vector< double,std::allocator< double > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vdouble2d_T" "', argument " "1"" of type '" "std::vector< std::vector< double,std::allocator< double > > > const &""'"); 
     }
     arg1 = ptr;
   }
@@ -11004,7 +11004,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_empty(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_empty(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -11017,7 +11017,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_empty(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_empty" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_empty" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = (bool)((std::vector< std::vector< double > > const *)arg1)->empty();
@@ -11028,7 +11028,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_size(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_size(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -11041,7 +11041,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_size(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_size" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_size" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = ((std::vector< std::vector< double > > const *)arg1)->size();
@@ -11052,7 +11052,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_swap(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_swap(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double,std::allocator< double > > > *arg2 = 0 ;
@@ -11063,18 +11063,18 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_swap(PyObject *self, PyObject *args) {
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_t_swap", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_T_swap", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_swap" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_swap" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], &argp2, SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t,  0 );
   if (!SWIG_IsOK(res2)) {
-    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vdouble2d_t_swap" "', argument " "2"" of type '" "std::vector< std::vector< double,std::allocator< double > > > &""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vdouble2d_T_swap" "', argument " "2"" of type '" "std::vector< std::vector< double,std::allocator< double > > > &""'"); 
   }
   if (!argp2) {
-    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_t_swap" "', argument " "2"" of type '" "std::vector< std::vector< double,std::allocator< double > > > &""'"); 
+    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_T_swap" "', argument " "2"" of type '" "std::vector< std::vector< double,std::allocator< double > > > &""'"); 
   }
   arg2 = reinterpret_cast< std::vector< std::vector< double,std::allocator< double > > > * >(argp2);
   (arg1)->swap(*arg2);
@@ -11085,7 +11085,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_begin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_begin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -11098,7 +11098,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_begin(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_begin" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_begin" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = (arg1)->begin();
@@ -11110,7 +11110,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_end(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_end(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -11123,7 +11123,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_end(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_end" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_end" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = (arg1)->end();
@@ -11135,7 +11135,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_rbegin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_rbegin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -11148,7 +11148,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_rbegin(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_rbegin" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_rbegin" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = (arg1)->rbegin();
@@ -11160,7 +11160,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_rend(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_rend(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -11173,7 +11173,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_rend(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_rend" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_rend" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = (arg1)->rend();
@@ -11185,7 +11185,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_clear(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_clear(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -11197,7 +11197,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_clear(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_clear" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_clear" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   (arg1)->clear();
@@ -11208,7 +11208,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_get_allocator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_get_allocator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -11221,7 +11221,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_get_allocator(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_get_allocator" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_get_allocator" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = ((std::vector< std::vector< double > > const *)arg1)->get_allocator();
@@ -11232,7 +11232,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vdouble2d_t__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vdouble2d_T__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > >::size_type arg1 ;
   size_t val1 ;
@@ -11243,7 +11243,7 @@ SWIGINTERN PyObject *_wrap_new_vdouble2d_t__SWIG_2(PyObject *self, Py_ssize_t no
   if ((nobjs < 1) || (nobjs > 1)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vdouble2d_t" "', argument " "1"" of type '" "std::vector< std::vector< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vdouble2d_T" "', argument " "1"" of type '" "std::vector< std::vector< double > >::size_type""'");
   } 
   arg1 = static_cast< std::vector< std::vector< double > >::size_type >(val1);
   result = (std::vector< std::vector< double > > *)new std::vector< std::vector< double > >(arg1);
@@ -11254,7 +11254,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_pop_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_pop_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -11266,7 +11266,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_pop_back(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_pop_back" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_pop_back" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   (arg1)->pop_back();
@@ -11277,7 +11277,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::size_type arg2 ;
@@ -11290,12 +11290,12 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_resize__SWIG_0(PyObject *self, Py_ssize_t
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_resize" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_resize" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_t_resize" "', argument " "2"" of type '" "std::vector< std::vector< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_T_resize" "', argument " "2"" of type '" "std::vector< std::vector< double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< double > >::size_type >(val2);
   (arg1)->resize(arg2);
@@ -11306,7 +11306,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::iterator arg2 ;
@@ -11320,18 +11320,18 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_erase__SWIG_0(PyObject *self, Py_ssize_t
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_erase" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_erase" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t_erase" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T_erase" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t_erase" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T_erase" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
     }
   }
   result = std_vector_Sl_std_vector_Sl_double_Sg__Sg__erase__SWIG_0(arg1,SWIG_STD_MOVE(arg2));
@@ -11343,7 +11343,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::iterator arg2 ;
@@ -11360,29 +11360,29 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_erase__SWIG_1(PyObject *self, Py_ssize_t
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_erase" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_erase" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t_erase" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T_erase" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t_erase" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T_erase" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
     }
   }
   res3 = SWIG_ConvertPtr(swig_obj[2], SWIG_as_voidptrptr(&iter3), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res3) || !iter3) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t_erase" "', argument " "3"" of type '" "std::vector< std::vector< double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T_erase" "', argument " "3"" of type '" "std::vector< std::vector< double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *>(iter3);
     if (iter_t) {
       arg3 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t_erase" "', argument " "3"" of type '" "std::vector< std::vector< double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T_erase" "', argument " "3"" of type '" "std::vector< std::vector< double > >::iterator""'");
     }
   }
   result = std_vector_Sl_std_vector_Sl_double_Sg__Sg__erase__SWIG_1(arg1,SWIG_STD_MOVE(arg2),SWIG_STD_MOVE(arg3));
@@ -11394,13 +11394,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_erase(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_erase(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_t_erase", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_T_erase", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -11411,7 +11411,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_erase(PyObject *self, PyObject *args) {
       int res = SWIG_ConvertPtr(argv[1], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
       _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *>(iter) != 0));
       if (_v) {
-        return _wrap_vdouble2d_t_erase__SWIG_0(self, argc, argv);
+        return _wrap_vdouble2d_T_erase__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -11428,14 +11428,14 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_erase(PyObject *self, PyObject *args) {
         int res = SWIG_ConvertPtr(argv[2], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
         _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *>(iter) != 0));
         if (_v) {
-          return _wrap_vdouble2d_t_erase__SWIG_1(self, argc, argv);
+          return _wrap_vdouble2d_T_erase__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_t_erase'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_T_erase'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< double > >::erase(std::vector< std::vector< double > >::iterator)\n"
     "    std::vector< std::vector< double > >::erase(std::vector< std::vector< double > >::iterator,std::vector< std::vector< double > >::iterator)\n");
@@ -11443,7 +11443,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vdouble2d_t__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vdouble2d_T__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > >::size_type arg1 ;
   std::vector< std::vector< double > >::value_type *arg2 = 0 ;
@@ -11456,17 +11456,17 @@ SWIGINTERN PyObject *_wrap_new_vdouble2d_t__SWIG_3(PyObject *self, Py_ssize_t no
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vdouble2d_t" "', argument " "1"" of type '" "std::vector< std::vector< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vdouble2d_T" "', argument " "1"" of type '" "std::vector< std::vector< double > >::size_type""'");
   } 
   arg1 = static_cast< std::vector< std::vector< double > >::size_type >(val1);
   {
     std::vector< double,std::allocator< double > > *ptr = (std::vector< double,std::allocator< double > > *)0;
     res2 = swig::asptr(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "new_vdouble2d_t" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "new_vdouble2d_T" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vdouble2d_t" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vdouble2d_T" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -11480,16 +11480,16 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vdouble2d_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_new_vdouble2d_T(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vdouble2d_t", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vdouble2d_T", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 0) {
-    return _wrap_new_vdouble2d_t__SWIG_0(self, argc, argv);
+    return _wrap_new_vdouble2d_T__SWIG_0(self, argc, argv);
   }
   if (argc == 1) {
     int _v = 0;
@@ -11498,7 +11498,7 @@ SWIGINTERN PyObject *_wrap_new_vdouble2d_t(PyObject *self, PyObject *args) {
       _v = SWIG_CheckState(res);
     }
     if (_v) {
-      return _wrap_new_vdouble2d_t__SWIG_2(self, argc, argv);
+      return _wrap_new_vdouble2d_T__SWIG_2(self, argc, argv);
     }
   }
   if (argc == 1) {
@@ -11506,7 +11506,7 @@ SWIGINTERN PyObject *_wrap_new_vdouble2d_t(PyObject *self, PyObject *args) {
     int res = swig::asptr(argv[0], (std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > >**)(0));
     _v = SWIG_CheckState(res);
     if (_v) {
-      return _wrap_new_vdouble2d_t__SWIG_1(self, argc, argv);
+      return _wrap_new_vdouble2d_T__SWIG_1(self, argc, argv);
     }
   }
   if (argc == 2) {
@@ -11519,13 +11519,13 @@ SWIGINTERN PyObject *_wrap_new_vdouble2d_t(PyObject *self, PyObject *args) {
       int res = swig::asptr(argv[1], (std::vector< double,std::allocator< double > >**)(0));
       _v = SWIG_CheckState(res);
       if (_v) {
-        return _wrap_new_vdouble2d_t__SWIG_3(self, argc, argv);
+        return _wrap_new_vdouble2d_T__SWIG_3(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vdouble2d_t'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vdouble2d_T'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< double > >::vector()\n"
     "    std::vector< std::vector< double > >::vector(std::vector< std::vector< double,std::allocator< double > > > const &)\n"
@@ -11535,7 +11535,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_push_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_push_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::value_type *arg2 = 0 ;
@@ -11545,20 +11545,20 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_push_back(PyObject *self, PyObject *args)
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_t_push_back", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_T_push_back", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_push_back" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_push_back" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   {
     std::vector< double,std::allocator< double > > *ptr = (std::vector< double,std::allocator< double > > *)0;
     res2 = swig::asptr(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vdouble2d_t_push_back" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vdouble2d_T_push_back" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_t_push_back" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_T_push_back" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -11572,7 +11572,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_front(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_front(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -11585,7 +11585,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_front(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_front" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_front" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = (std::vector< std::vector< double > >::value_type *) &((std::vector< std::vector< double > > const *)arg1)->front();
@@ -11597,7 +11597,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -11610,7 +11610,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_back(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_back" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_back" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = (std::vector< std::vector< double > >::value_type *) &((std::vector< std::vector< double > > const *)arg1)->back();
@@ -11622,7 +11622,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_assign(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_assign(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::size_type arg2 ;
@@ -11635,25 +11635,25 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_assign(PyObject *self, PyObject *args) {
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_t_assign", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_T_assign", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_assign" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_assign" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_t_assign" "', argument " "2"" of type '" "std::vector< std::vector< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_T_assign" "', argument " "2"" of type '" "std::vector< std::vector< double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< double > >::size_type >(val2);
   {
     std::vector< double,std::allocator< double > > *ptr = (std::vector< double,std::allocator< double > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble2d_t_assign" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble2d_T_assign" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_t_assign" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_T_assign" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -11667,7 +11667,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::size_type arg2 ;
@@ -11682,22 +11682,22 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_resize__SWIG_1(PyObject *self, Py_ssize_t
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_resize" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_resize" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_t_resize" "', argument " "2"" of type '" "std::vector< std::vector< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_T_resize" "', argument " "2"" of type '" "std::vector< std::vector< double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< double > >::size_type >(val2);
   {
     std::vector< double,std::allocator< double > > *ptr = (std::vector< double,std::allocator< double > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble2d_t_resize" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble2d_T_resize" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_t_resize" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_T_resize" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -11711,13 +11711,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_resize(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_resize(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_t_resize", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_T_resize", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -11729,7 +11729,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_resize(PyObject *self, PyObject *args) {
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vdouble2d_t_resize__SWIG_0(self, argc, argv);
+        return _wrap_vdouble2d_T_resize__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -11746,14 +11746,14 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_resize(PyObject *self, PyObject *args) {
         int res = swig::asptr(argv[2], (std::vector< double,std::allocator< double > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vdouble2d_t_resize__SWIG_1(self, argc, argv);
+          return _wrap_vdouble2d_T_resize__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_t_resize'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_T_resize'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< double > >::resize(std::vector< std::vector< double > >::size_type)\n"
     "    std::vector< std::vector< double > >::resize(std::vector< std::vector< double > >::size_type,std::vector< std::vector< double > >::value_type const &)\n");
@@ -11761,7 +11761,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::iterator arg2 ;
@@ -11777,28 +11777,28 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_insert__SWIG_0(PyObject *self, Py_ssize_t
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_insert" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_insert" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t_insert" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T_insert" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t_insert" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T_insert" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
     }
   }
   {
     std::vector< double,std::allocator< double > > *ptr = (std::vector< double,std::allocator< double > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble2d_t_insert" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble2d_T_insert" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_t_insert" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_T_insert" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -11813,7 +11813,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::iterator arg2 ;
@@ -11831,33 +11831,33 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_insert__SWIG_1(PyObject *self, Py_ssize_t
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_insert" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_insert" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t_insert" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T_insert" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t_insert" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T_insert" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_size_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble2d_t_insert" "', argument " "3"" of type '" "std::vector< std::vector< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble2d_T_insert" "', argument " "3"" of type '" "std::vector< std::vector< double > >::size_type""'");
   } 
   arg3 = static_cast< std::vector< std::vector< double > >::size_type >(val3);
   {
     std::vector< double,std::allocator< double > > *ptr = (std::vector< double,std::allocator< double > > *)0;
     res4 = swig::asptr(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vdouble2d_t_insert" "', argument " "4"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vdouble2d_T_insert" "', argument " "4"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_t_insert" "', argument " "4"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_T_insert" "', argument " "4"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     arg4 = ptr;
   }
@@ -11871,13 +11871,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_insert(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_insert(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_t_insert", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_T_insert", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -11891,7 +11891,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_insert(PyObject *self, PyObject *args) {
         int res = swig::asptr(argv[2], (std::vector< double,std::allocator< double > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vdouble2d_t_insert__SWIG_0(self, argc, argv);
+          return _wrap_vdouble2d_T_insert__SWIG_0(self, argc, argv);
         }
       }
     }
@@ -11913,7 +11913,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_insert(PyObject *self, PyObject *args) {
           int res = swig::asptr(argv[3], (std::vector< double,std::allocator< double > >**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vdouble2d_t_insert__SWIG_1(self, argc, argv);
+            return _wrap_vdouble2d_T_insert__SWIG_1(self, argc, argv);
           }
         }
       }
@@ -11921,7 +11921,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_insert(PyObject *self, PyObject *args) {
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_t_insert'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_T_insert'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< double > >::insert(std::vector< std::vector< double > >::iterator,std::vector< std::vector< double > >::value_type const &)\n"
     "    std::vector< std::vector< double > >::insert(std::vector< std::vector< double > >::iterator,std::vector< std::vector< double > >::size_type,std::vector< std::vector< double > >::value_type const &)\n");
@@ -11929,7 +11929,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_reserve(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_reserve(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::size_type arg2 ;
@@ -11940,15 +11940,15 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_reserve(PyObject *self, PyObject *args) {
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_t_reserve", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_T_reserve", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_reserve" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_reserve" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_t_reserve" "', argument " "2"" of type '" "std::vector< std::vector< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_T_reserve" "', argument " "2"" of type '" "std::vector< std::vector< double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< double > >::size_type >(val2);
   (arg1)->reserve(arg2);
@@ -11959,7 +11959,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_capacity(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_capacity(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -11972,7 +11972,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_capacity(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_capacity" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_capacity" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = ((std::vector< std::vector< double > > const *)arg1)->capacity();
@@ -11983,7 +11983,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_delete_vdouble2d_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_delete_vdouble2d_T(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -11995,7 +11995,7 @@ SWIGINTERN PyObject *_wrap_delete_vdouble2d_t(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, SWIG_POINTER_DISOWN |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vdouble2d_t" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vdouble2d_T" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   {
@@ -12016,18 +12016,18 @@ fail:
 }
 
 
-SWIGINTERN PyObject *vdouble2d_t_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vdouble2d_T_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   PyObject *obj;
   if (!SWIG_Python_UnpackTuple(args, "swigregister", 1, 1, &obj)) return NULL;
   SWIG_TypeNewClientData(SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, SWIG_NewClientData(obj));
   return SWIG_Py_Void();
 }
 
-SWIGINTERN PyObject *vdouble2d_t_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vdouble2d_T_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   return SWIG_Python_InitShadowInstance(args);
 }
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_iterator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_iterator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   PyObject **arg2 = (PyObject **) 0 ;
@@ -12042,7 +12042,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_iterator(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_iterator" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_iterator" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = (swig::SwigPyIterator *)std_vector_Sl_int_Sg__iterator(arg1,arg2);
@@ -12053,7 +12053,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___nonzero__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___nonzero__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -12066,7 +12066,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___nonzero__(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___nonzero__" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___nonzero__" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = (bool)std_vector_Sl_int_Sg____nonzero__((std::vector< int > const *)arg1);
@@ -12077,7 +12077,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___bool__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___bool__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -12090,7 +12090,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___bool__(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___bool__" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___bool__" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = (bool)std_vector_Sl_int_Sg____bool__((std::vector< int > const *)arg1);
@@ -12101,7 +12101,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___len__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___len__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -12114,7 +12114,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___len__(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___len__" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___len__" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = std_vector_Sl_int_Sg____len__((std::vector< int > const *)arg1);
@@ -12125,7 +12125,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___getslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___getslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::difference_type arg2 ;
@@ -12140,20 +12140,20 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___getslice__(PyObject *self, PyObjec
   std::vector< int,std::allocator< int > > *result = 0 ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_integer_t___getslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_integer_T___getslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___getslice__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___getslice__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t___getslice__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T___getslice__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< int >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_t___getslice__" "', argument " "3"" of type '" "std::vector< int >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_T___getslice__" "', argument " "3"" of type '" "std::vector< int >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< int >::difference_type >(val3);
   try {
@@ -12170,7 +12170,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::difference_type arg2 ;
@@ -12186,17 +12186,17 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setslice____SWIG_0(PyObject *self,
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___setslice__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___setslice__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t___setslice__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T___setslice__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< int >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_t___setslice__" "', argument " "3"" of type '" "std::vector< int >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_T___setslice__" "', argument " "3"" of type '" "std::vector< int >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< int >::difference_type >(val3);
   try {
@@ -12213,7 +12213,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::difference_type arg2 ;
@@ -12231,27 +12231,27 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setslice____SWIG_1(PyObject *self,
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___setslice__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___setslice__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t___setslice__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T___setslice__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< int >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_t___setslice__" "', argument " "3"" of type '" "std::vector< int >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_T___setslice__" "', argument " "3"" of type '" "std::vector< int >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< int >::difference_type >(val3);
   {
     std::vector< int,std::allocator< int > > *ptr = (std::vector< int,std::allocator< int > > *)0;
     res4 = swig::asptr(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_integer_t___setslice__" "', argument " "4"" of type '" "std::vector< int,std::allocator< int > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_integer_T___setslice__" "', argument " "4"" of type '" "std::vector< int,std::allocator< int > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_integer_t___setslice__" "', argument " "4"" of type '" "std::vector< int,std::allocator< int > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_integer_T___setslice__" "', argument " "4"" of type '" "std::vector< int,std::allocator< int > > const &""'"); 
     }
     arg4 = ptr;
   }
@@ -12271,13 +12271,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___setslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___setslice__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_t___setslice__", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_T___setslice__", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -12294,7 +12294,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setslice__(PyObject *self, PyObjec
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_integer_t___setslice____SWIG_0(self, argc, argv);
+          return _wrap_vector_integer_T___setslice____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -12317,7 +12317,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setslice__(PyObject *self, PyObjec
           int res = swig::asptr(argv[3], (std::vector< int,std::allocator< int > >**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vector_integer_t___setslice____SWIG_1(self, argc, argv);
+            return _wrap_vector_integer_T___setslice____SWIG_1(self, argc, argv);
           }
         }
       }
@@ -12325,7 +12325,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setslice__(PyObject *self, PyObjec
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_t___setslice__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_T___setslice__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< int >::__setslice__(std::vector< int >::difference_type,std::vector< int >::difference_type)\n"
     "    std::vector< int >::__setslice__(std::vector< int >::difference_type,std::vector< int >::difference_type,std::vector< int,std::allocator< int > > const &)\n");
@@ -12333,7 +12333,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___delslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___delslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::difference_type arg2 ;
@@ -12347,20 +12347,20 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___delslice__(PyObject *self, PyObjec
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_integer_t___delslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_integer_T___delslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___delslice__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___delslice__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t___delslice__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T___delslice__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< int >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_t___delslice__" "', argument " "3"" of type '" "std::vector< int >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_T___delslice__" "', argument " "3"" of type '" "std::vector< int >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< int >::difference_type >(val3);
   try {
@@ -12377,7 +12377,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::difference_type arg2 ;
@@ -12390,12 +12390,12 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___delitem____SWIG_0(PyObject *self,
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___delitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___delitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t___delitem__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T___delitem__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< int >::difference_type >(val2);
   try {
@@ -12412,7 +12412,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -12424,12 +12424,12 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___getitem____SWIG_0(PyObject *self,
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___getitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___getitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -12447,7 +12447,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -12460,12 +12460,12 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setitem____SWIG_0(PyObject *self,
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___setitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___setitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -12473,10 +12473,10 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setitem____SWIG_0(PyObject *self,
     std::vector< int,std::allocator< int > > *ptr = (std::vector< int,std::allocator< int > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_integer_t___setitem__" "', argument " "3"" of type '" "std::vector< int,std::allocator< int > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_integer_T___setitem__" "', argument " "3"" of type '" "std::vector< int,std::allocator< int > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_integer_t___setitem__" "', argument " "3"" of type '" "std::vector< int,std::allocator< int > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_integer_T___setitem__" "', argument " "3"" of type '" "std::vector< int,std::allocator< int > > const &""'"); 
     }
     arg3 = ptr;
   }
@@ -12496,7 +12496,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -12507,12 +12507,12 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setitem____SWIG_1(PyObject *self,
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___setitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___setitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -12530,7 +12530,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -12541,12 +12541,12 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___delitem____SWIG_1(PyObject *self,
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___delitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___delitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -12564,13 +12564,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___delitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___delitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_t___delitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_T___delitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -12581,7 +12581,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___delitem__(PyObject *self, PyObject
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_integer_t___delitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_integer_T___delitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -12595,13 +12595,13 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___delitem__(PyObject *self, PyObject
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_integer_t___delitem____SWIG_0(self, argc, argv);
+        return _wrap_vector_integer_T___delitem____SWIG_0(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_t___delitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_T___delitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< int >::__delitem__(std::vector< int >::difference_type)\n"
     "    std::vector< int >::__delitem__(SWIGPY_SLICEOBJECT *)\n");
@@ -12609,7 +12609,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::difference_type arg2 ;
@@ -12623,12 +12623,12 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___getitem____SWIG_1(PyObject *self,
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___getitem__" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___getitem__" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t___getitem__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T___getitem__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< int >::difference_type >(val2);
   try {
@@ -12644,13 +12644,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___getitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___getitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_t___getitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_T___getitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -12661,7 +12661,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___getitem__(PyObject *self, PyObject
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_integer_t___getitem____SWIG_0(self, argc, argv);
+        return _wrap_vector_integer_T___getitem____SWIG_0(self, argc, argv);
       }
     }
   }
@@ -12675,13 +12675,13 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___getitem__(PyObject *self, PyObject
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_integer_t___getitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_integer_T___getitem____SWIG_1(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_t___getitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_T___getitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< int >::__getitem__(SWIGPY_SLICEOBJECT *)\n"
     "    std::vector< int >::__getitem__(std::vector< int >::difference_type) const\n");
@@ -12689,7 +12689,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::difference_type arg2 ;
@@ -12706,17 +12706,17 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setitem____SWIG_2(PyObject *self,
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___setitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___setitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t___setitem__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T___setitem__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< int >::difference_type >(val2);
   ecode3 = SWIG_AsVal_int(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_t___setitem__" "', argument " "3"" of type '" "std::vector< int >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_T___setitem__" "', argument " "3"" of type '" "std::vector< int >::value_type""'");
   } 
   temp3 = static_cast< std::vector< int >::value_type >(val3);
   arg3 = &temp3;
@@ -12732,13 +12732,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___setitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___setitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_t___setitem__", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_T___setitem__", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -12749,7 +12749,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setitem__(PyObject *self, PyObject
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_integer_t___setitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_integer_T___setitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -12765,7 +12765,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setitem__(PyObject *self, PyObject
         int res = swig::asptr(argv[2], (std::vector< int,std::allocator< int > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vector_integer_t___setitem____SWIG_0(self, argc, argv);
+          return _wrap_vector_integer_T___setitem____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -12785,14 +12785,14 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setitem__(PyObject *self, PyObject
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_integer_t___setitem____SWIG_2(self, argc, argv);
+          return _wrap_vector_integer_T___setitem____SWIG_2(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_t___setitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_T___setitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< int >::__setitem__(SWIGPY_SLICEOBJECT *,std::vector< int,std::allocator< int > > const &)\n"
     "    std::vector< int >::__setitem__(SWIGPY_SLICEOBJECT *)\n"
@@ -12801,7 +12801,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_pop(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_pop(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -12814,7 +12814,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_pop(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_pop" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_pop" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   try {
@@ -12829,7 +12829,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_append(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_append(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::value_type *arg2 = 0 ;
@@ -12841,15 +12841,15 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_append(PyObject *self, PyObject *arg
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_integer_t_append", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_integer_T_append", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_append" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_append" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_int(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t_append" "', argument " "2"" of type '" "std::vector< int >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T_append" "', argument " "2"" of type '" "std::vector< int >::value_type""'");
   } 
   temp2 = static_cast< std::vector< int >::value_type >(val2);
   arg2 = &temp2;
@@ -12861,7 +12861,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_integer_t__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
+SWIGINTERN PyObject *_wrap_new_vector_integer_T__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
   PyObject *resultobj = 0;
   std::vector< int > *result = 0 ;
   
@@ -12875,7 +12875,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_integer_t__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_integer_T__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = 0 ;
   int res1 = SWIG_OLDOBJ ;
@@ -12887,10 +12887,10 @@ SWIGINTERN PyObject *_wrap_new_vector_integer_t__SWIG_1(PyObject *self, Py_ssize
     std::vector< int,std::allocator< int > > *ptr = (std::vector< int,std::allocator< int > > *)0;
     res1 = swig::asptr(swig_obj[0], &ptr);
     if (!SWIG_IsOK(res1)) {
-      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vector_integer_t" "', argument " "1"" of type '" "std::vector< int > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vector_integer_T" "', argument " "1"" of type '" "std::vector< int > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_integer_t" "', argument " "1"" of type '" "std::vector< int > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_integer_T" "', argument " "1"" of type '" "std::vector< int > const &""'"); 
     }
     arg1 = ptr;
   }
@@ -12904,7 +12904,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_empty(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_empty(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -12917,7 +12917,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_empty(PyObject *self, PyObject *args
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_empty" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_empty" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = (bool)((std::vector< int > const *)arg1)->empty();
@@ -12928,7 +12928,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_size(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_size(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -12941,7 +12941,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_size(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_size" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_size" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = ((std::vector< int > const *)arg1)->size();
@@ -12952,7 +12952,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_swap(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_swap(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int > *arg2 = 0 ;
@@ -12963,18 +12963,18 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_swap(PyObject *self, PyObject *args)
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_integer_t_swap", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_integer_T_swap", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_swap" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_swap" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], &argp2, SWIGTYPE_p_std__vectorT_int_t,  0 );
   if (!SWIG_IsOK(res2)) {
-    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_integer_t_swap" "', argument " "2"" of type '" "std::vector< int > &""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_integer_T_swap" "', argument " "2"" of type '" "std::vector< int > &""'"); 
   }
   if (!argp2) {
-    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_integer_t_swap" "', argument " "2"" of type '" "std::vector< int > &""'"); 
+    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_integer_T_swap" "', argument " "2"" of type '" "std::vector< int > &""'"); 
   }
   arg2 = reinterpret_cast< std::vector< int > * >(argp2);
   (arg1)->swap(*arg2);
@@ -12985,7 +12985,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_begin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_begin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -12998,7 +12998,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_begin(PyObject *self, PyObject *args
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_begin" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_begin" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = (arg1)->begin();
@@ -13010,7 +13010,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_end(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_end(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -13023,7 +13023,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_end(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_end" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_end" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = (arg1)->end();
@@ -13035,7 +13035,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_rbegin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_rbegin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -13048,7 +13048,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_rbegin(PyObject *self, PyObject *arg
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_rbegin" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_rbegin" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = (arg1)->rbegin();
@@ -13060,7 +13060,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_rend(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_rend(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -13073,7 +13073,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_rend(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_rend" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_rend" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = (arg1)->rend();
@@ -13085,7 +13085,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_clear(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_clear(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -13097,7 +13097,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_clear(PyObject *self, PyObject *args
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_clear" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_clear" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   (arg1)->clear();
@@ -13108,7 +13108,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_get_allocator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_get_allocator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -13121,7 +13121,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_get_allocator(PyObject *self, PyObje
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_get_allocator" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_get_allocator" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = ((std::vector< int > const *)arg1)->get_allocator();
@@ -13132,7 +13132,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_integer_t__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_integer_T__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int >::size_type arg1 ;
   size_t val1 ;
@@ -13143,7 +13143,7 @@ SWIGINTERN PyObject *_wrap_new_vector_integer_t__SWIG_2(PyObject *self, Py_ssize
   if ((nobjs < 1) || (nobjs > 1)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_integer_t" "', argument " "1"" of type '" "std::vector< int >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_integer_T" "', argument " "1"" of type '" "std::vector< int >::size_type""'");
   } 
   arg1 = static_cast< std::vector< int >::size_type >(val1);
   result = (std::vector< int > *)new std::vector< int >(arg1);
@@ -13154,7 +13154,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_pop_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_pop_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -13166,7 +13166,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_pop_back(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_pop_back" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_pop_back" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   (arg1)->pop_back();
@@ -13177,7 +13177,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::size_type arg2 ;
@@ -13190,12 +13190,12 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_resize__SWIG_0(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_resize" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_resize" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t_resize" "', argument " "2"" of type '" "std::vector< int >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T_resize" "', argument " "2"" of type '" "std::vector< int >::size_type""'");
   } 
   arg2 = static_cast< std::vector< int >::size_type >(val2);
   (arg1)->resize(arg2);
@@ -13206,7 +13206,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::iterator arg2 ;
@@ -13220,18 +13220,18 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_erase__SWIG_0(PyObject *self, Py_ssi
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_erase" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_erase" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t_erase" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T_erase" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< int >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< int >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t_erase" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T_erase" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
     }
   }
   result = std_vector_Sl_int_Sg__erase__SWIG_0(arg1,SWIG_STD_MOVE(arg2));
@@ -13243,7 +13243,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::iterator arg2 ;
@@ -13260,29 +13260,29 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_erase__SWIG_1(PyObject *self, Py_ssi
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_erase" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_erase" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t_erase" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T_erase" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< int >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< int >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t_erase" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T_erase" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
     }
   }
   res3 = SWIG_ConvertPtr(swig_obj[2], SWIG_as_voidptrptr(&iter3), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res3) || !iter3) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t_erase" "', argument " "3"" of type '" "std::vector< int >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T_erase" "', argument " "3"" of type '" "std::vector< int >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< int >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< int >::iterator > *>(iter3);
     if (iter_t) {
       arg3 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t_erase" "', argument " "3"" of type '" "std::vector< int >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T_erase" "', argument " "3"" of type '" "std::vector< int >::iterator""'");
     }
   }
   result = std_vector_Sl_int_Sg__erase__SWIG_1(arg1,SWIG_STD_MOVE(arg2),SWIG_STD_MOVE(arg3));
@@ -13294,13 +13294,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_erase(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_erase(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_t_erase", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_T_erase", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -13311,7 +13311,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_erase(PyObject *self, PyObject *args
       int res = SWIG_ConvertPtr(argv[1], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
       _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< int >::iterator > *>(iter) != 0));
       if (_v) {
-        return _wrap_vector_integer_t_erase__SWIG_0(self, argc, argv);
+        return _wrap_vector_integer_T_erase__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -13328,14 +13328,14 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_erase(PyObject *self, PyObject *args
         int res = SWIG_ConvertPtr(argv[2], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
         _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< int >::iterator > *>(iter) != 0));
         if (_v) {
-          return _wrap_vector_integer_t_erase__SWIG_1(self, argc, argv);
+          return _wrap_vector_integer_T_erase__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_t_erase'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_T_erase'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< int >::erase(std::vector< int >::iterator)\n"
     "    std::vector< int >::erase(std::vector< int >::iterator,std::vector< int >::iterator)\n");
@@ -13343,7 +13343,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_integer_t__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_integer_T__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int >::size_type arg1 ;
   std::vector< int >::value_type *arg2 = 0 ;
@@ -13358,12 +13358,12 @@ SWIGINTERN PyObject *_wrap_new_vector_integer_t__SWIG_3(PyObject *self, Py_ssize
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_integer_t" "', argument " "1"" of type '" "std::vector< int >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_integer_T" "', argument " "1"" of type '" "std::vector< int >::size_type""'");
   } 
   arg1 = static_cast< std::vector< int >::size_type >(val1);
   ecode2 = SWIG_AsVal_int(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "new_vector_integer_t" "', argument " "2"" of type '" "std::vector< int >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "new_vector_integer_T" "', argument " "2"" of type '" "std::vector< int >::value_type""'");
   } 
   temp2 = static_cast< std::vector< int >::value_type >(val2);
   arg2 = &temp2;
@@ -13375,16 +13375,16 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_integer_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_new_vector_integer_T(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vector_integer_t", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vector_integer_T", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 0) {
-    return _wrap_new_vector_integer_t__SWIG_0(self, argc, argv);
+    return _wrap_new_vector_integer_T__SWIG_0(self, argc, argv);
   }
   if (argc == 1) {
     int _v = 0;
@@ -13393,7 +13393,7 @@ SWIGINTERN PyObject *_wrap_new_vector_integer_t(PyObject *self, PyObject *args)
       _v = SWIG_CheckState(res);
     }
     if (_v) {
-      return _wrap_new_vector_integer_t__SWIG_2(self, argc, argv);
+      return _wrap_new_vector_integer_T__SWIG_2(self, argc, argv);
     }
   }
   if (argc == 1) {
@@ -13401,7 +13401,7 @@ SWIGINTERN PyObject *_wrap_new_vector_integer_t(PyObject *self, PyObject *args)
     int res = swig::asptr(argv[0], (std::vector< int,std::allocator< int > >**)(0));
     _v = SWIG_CheckState(res);
     if (_v) {
-      return _wrap_new_vector_integer_t__SWIG_1(self, argc, argv);
+      return _wrap_new_vector_integer_T__SWIG_1(self, argc, argv);
     }
   }
   if (argc == 2) {
@@ -13416,13 +13416,13 @@ SWIGINTERN PyObject *_wrap_new_vector_integer_t(PyObject *self, PyObject *args)
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_new_vector_integer_t__SWIG_3(self, argc, argv);
+        return _wrap_new_vector_integer_T__SWIG_3(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vector_integer_t'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vector_integer_T'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< int >::vector()\n"
     "    std::vector< int >::vector(std::vector< int > const &)\n"
@@ -13432,7 +13432,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_push_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_push_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::value_type *arg2 = 0 ;
@@ -13444,15 +13444,15 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_push_back(PyObject *self, PyObject *
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_integer_t_push_back", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_integer_T_push_back", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_push_back" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_push_back" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_int(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t_push_back" "', argument " "2"" of type '" "std::vector< int >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T_push_back" "', argument " "2"" of type '" "std::vector< int >::value_type""'");
   } 
   temp2 = static_cast< std::vector< int >::value_type >(val2);
   arg2 = &temp2;
@@ -13464,7 +13464,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_front(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_front(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -13477,7 +13477,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_front(PyObject *self, PyObject *args
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_front" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_front" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = (std::vector< int >::value_type *) &((std::vector< int > const *)arg1)->front();
@@ -13489,7 +13489,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -13502,7 +13502,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_back(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_back" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_back" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = (std::vector< int >::value_type *) &((std::vector< int > const *)arg1)->back();
@@ -13514,7 +13514,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_assign(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_assign(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::size_type arg2 ;
@@ -13529,20 +13529,20 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_assign(PyObject *self, PyObject *arg
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_integer_t_assign", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_integer_T_assign", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_assign" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_assign" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t_assign" "', argument " "2"" of type '" "std::vector< int >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T_assign" "', argument " "2"" of type '" "std::vector< int >::size_type""'");
   } 
   arg2 = static_cast< std::vector< int >::size_type >(val2);
   ecode3 = SWIG_AsVal_int(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_t_assign" "', argument " "3"" of type '" "std::vector< int >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_T_assign" "', argument " "3"" of type '" "std::vector< int >::value_type""'");
   } 
   temp3 = static_cast< std::vector< int >::value_type >(val3);
   arg3 = &temp3;
@@ -13554,7 +13554,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::size_type arg2 ;
@@ -13571,17 +13571,17 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_resize__SWIG_1(PyObject *self, Py_ss
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_resize" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_resize" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t_resize" "', argument " "2"" of type '" "std::vector< int >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T_resize" "', argument " "2"" of type '" "std::vector< int >::size_type""'");
   } 
   arg2 = static_cast< std::vector< int >::size_type >(val2);
   ecode3 = SWIG_AsVal_int(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_t_resize" "', argument " "3"" of type '" "std::vector< int >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_T_resize" "', argument " "3"" of type '" "std::vector< int >::value_type""'");
   } 
   temp3 = static_cast< std::vector< int >::value_type >(val3);
   arg3 = &temp3;
@@ -13593,13 +13593,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_resize(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_resize(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_t_resize", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_T_resize", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -13611,7 +13611,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_resize(PyObject *self, PyObject *arg
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_integer_t_resize__SWIG_0(self, argc, argv);
+        return _wrap_vector_integer_T_resize__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -13630,14 +13630,14 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_resize(PyObject *self, PyObject *arg
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_integer_t_resize__SWIG_1(self, argc, argv);
+          return _wrap_vector_integer_T_resize__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_t_resize'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_T_resize'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< int >::resize(std::vector< int >::size_type)\n"
     "    std::vector< int >::resize(std::vector< int >::size_type,std::vector< int >::value_type const &)\n");
@@ -13645,7 +13645,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::iterator arg2 ;
@@ -13663,23 +13663,23 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_insert__SWIG_0(PyObject *self, Py_ss
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_insert" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_insert" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t_insert" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T_insert" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< int >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< int >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t_insert" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T_insert" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_int(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_t_insert" "', argument " "3"" of type '" "std::vector< int >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_T_insert" "', argument " "3"" of type '" "std::vector< int >::value_type""'");
   } 
   temp3 = static_cast< std::vector< int >::value_type >(val3);
   arg3 = &temp3;
@@ -13692,7 +13692,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::iterator arg2 ;
@@ -13712,28 +13712,28 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_insert__SWIG_1(PyObject *self, Py_ss
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_insert" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_insert" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t_insert" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T_insert" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< int >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< int >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t_insert" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T_insert" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_size_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_t_insert" "', argument " "3"" of type '" "std::vector< int >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_T_insert" "', argument " "3"" of type '" "std::vector< int >::size_type""'");
   } 
   arg3 = static_cast< std::vector< int >::size_type >(val3);
   ecode4 = SWIG_AsVal_int(swig_obj[3], &val4);
   if (!SWIG_IsOK(ecode4)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode4), "in method '" "vector_integer_t_insert" "', argument " "4"" of type '" "std::vector< int >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode4), "in method '" "vector_integer_T_insert" "', argument " "4"" of type '" "std::vector< int >::value_type""'");
   } 
   temp4 = static_cast< std::vector< int >::value_type >(val4);
   arg4 = &temp4;
@@ -13745,13 +13745,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_insert(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_insert(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_t_insert", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_T_insert", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -13767,7 +13767,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_insert(PyObject *self, PyObject *arg
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_integer_t_insert__SWIG_0(self, argc, argv);
+          return _wrap_vector_integer_T_insert__SWIG_0(self, argc, argv);
         }
       }
     }
@@ -13791,7 +13791,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_insert(PyObject *self, PyObject *arg
             _v = SWIG_CheckState(res);
           }
           if (_v) {
-            return _wrap_vector_integer_t_insert__SWIG_1(self, argc, argv);
+            return _wrap_vector_integer_T_insert__SWIG_1(self, argc, argv);
           }
         }
       }
@@ -13799,7 +13799,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_insert(PyObject *self, PyObject *arg
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_t_insert'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_T_insert'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< int >::insert(std::vector< int >::iterator,std::vector< int >::value_type const &)\n"
     "    std::vector< int >::insert(std::vector< int >::iterator,std::vector< int >::size_type,std::vector< int >::value_type const &)\n");
@@ -13807,7 +13807,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_reserve(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_reserve(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::size_type arg2 ;
@@ -13818,15 +13818,15 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_reserve(PyObject *self, PyObject *ar
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_integer_t_reserve", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_integer_T_reserve", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_reserve" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_reserve" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t_reserve" "', argument " "2"" of type '" "std::vector< int >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T_reserve" "', argument " "2"" of type '" "std::vector< int >::size_type""'");
   } 
   arg2 = static_cast< std::vector< int >::size_type >(val2);
   (arg1)->reserve(arg2);
@@ -13837,7 +13837,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_capacity(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_capacity(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -13850,7 +13850,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_capacity(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_capacity" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_capacity" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = ((std::vector< int > const *)arg1)->capacity();
@@ -13861,7 +13861,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_delete_vector_integer_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_delete_vector_integer_T(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -13873,7 +13873,7 @@ SWIGINTERN PyObject *_wrap_delete_vector_integer_t(PyObject *self, PyObject *arg
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, SWIG_POINTER_DISOWN |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vector_integer_t" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vector_integer_T" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   {
@@ -13894,18 +13894,18 @@ fail:
 }
 
 
-SWIGINTERN PyObject *vector_integer_t_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vector_integer_T_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   PyObject *obj;
   if (!SWIG_Python_UnpackTuple(args, "swigregister", 1, 1, &obj)) return NULL;
   SWIG_TypeNewClientData(SWIGTYPE_p_std__vectorT_int_t, SWIG_NewClientData(obj));
   return SWIG_Py_Void();
 }
 
-SWIGINTERN PyObject *vector_integer_t_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vector_integer_T_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   return SWIG_Python_InitShadowInstance(args);
 }
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_iterator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_iterator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   PyObject **arg2 = (PyObject **) 0 ;
@@ -13920,7 +13920,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_iterator(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_iterator" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_iterator" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = (swig::SwigPyIterator *)std_vector_Sl_std_vector_Sl_int_Sg__Sg__iterator(arg1,arg2);
@@ -13931,7 +13931,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___nonzero__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___nonzero__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -13944,7 +13944,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___nonzero__(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___nonzero__" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___nonzero__" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = (bool)std_vector_Sl_std_vector_Sl_int_Sg__Sg____nonzero__((std::vector< std::vector< int > > const *)arg1);
@@ -13955,7 +13955,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___bool__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___bool__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -13968,7 +13968,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___bool__(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___bool__" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___bool__" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = (bool)std_vector_Sl_std_vector_Sl_int_Sg__Sg____bool__((std::vector< std::vector< int > > const *)arg1);
@@ -13979,7 +13979,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___len__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___len__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -13992,7 +13992,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___len__(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___len__" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___len__" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = std_vector_Sl_std_vector_Sl_int_Sg__Sg____len__((std::vector< std::vector< int > > const *)arg1);
@@ -14003,7 +14003,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___getslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___getslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::difference_type arg2 ;
@@ -14018,20 +14018,20 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___getslice__(PyObject *self, PyObject *a
   std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > *result = 0 ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_t___getslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_T___getslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___getslice__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___getslice__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_t___getslice__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_T___getslice__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< int > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vinteger2d_t___getslice__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vinteger2d_T___getslice__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::vector< int > >::difference_type >(val3);
   try {
@@ -14048,7 +14048,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::difference_type arg2 ;
@@ -14064,17 +14064,17 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setslice____SWIG_0(PyObject *self, Py_
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___setslice__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___setslice__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_t___setslice__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_T___setslice__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< int > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vinteger2d_t___setslice__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vinteger2d_T___setslice__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::vector< int > >::difference_type >(val3);
   try {
@@ -14091,7 +14091,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::difference_type arg2 ;
@@ -14109,27 +14109,27 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setslice____SWIG_1(PyObject *self, Py_
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___setslice__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___setslice__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_t___setslice__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_T___setslice__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< int > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vinteger2d_t___setslice__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vinteger2d_T___setslice__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::vector< int > >::difference_type >(val3);
   {
     std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > *ptr = (std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > *)0;
     res4 = swig::asptr(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vinteger2d_t___setslice__" "', argument " "4"" of type '" "std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vinteger2d_T___setslice__" "', argument " "4"" of type '" "std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_t___setslice__" "', argument " "4"" of type '" "std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_T___setslice__" "', argument " "4"" of type '" "std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > const &""'"); 
     }
     arg4 = ptr;
   }
@@ -14149,13 +14149,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___setslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___setslice__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_t___setslice__", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_T___setslice__", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -14172,7 +14172,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setslice__(PyObject *self, PyObject *a
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vinteger2d_t___setslice____SWIG_0(self, argc, argv);
+          return _wrap_vinteger2d_T___setslice____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -14195,7 +14195,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setslice__(PyObject *self, PyObject *a
           int res = swig::asptr(argv[3], (std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > >**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vinteger2d_t___setslice____SWIG_1(self, argc, argv);
+            return _wrap_vinteger2d_T___setslice____SWIG_1(self, argc, argv);
           }
         }
       }
@@ -14203,7 +14203,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setslice__(PyObject *self, PyObject *a
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_t___setslice__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_T___setslice__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< int > >::__setslice__(std::vector< std::vector< int > >::difference_type,std::vector< std::vector< int > >::difference_type)\n"
     "    std::vector< std::vector< int > >::__setslice__(std::vector< std::vector< int > >::difference_type,std::vector< std::vector< int > >::difference_type,std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > const &)\n");
@@ -14211,7 +14211,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___delslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___delslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::difference_type arg2 ;
@@ -14225,20 +14225,20 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___delslice__(PyObject *self, PyObject *a
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_t___delslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_T___delslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___delslice__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___delslice__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_t___delslice__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_T___delslice__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< int > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vinteger2d_t___delslice__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vinteger2d_T___delslice__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::vector< int > >::difference_type >(val3);
   try {
@@ -14255,7 +14255,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::difference_type arg2 ;
@@ -14268,12 +14268,12 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___delitem____SWIG_0(PyObject *self, Py_s
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___delitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___delitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_t___delitem__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_T___delitem__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< int > >::difference_type >(val2);
   try {
@@ -14290,7 +14290,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -14302,12 +14302,12 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___getitem____SWIG_0(PyObject *self, Py_s
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___getitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___getitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -14325,7 +14325,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -14338,12 +14338,12 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setitem____SWIG_0(PyObject *self, Py_s
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -14351,10 +14351,10 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setitem____SWIG_0(PyObject *self, Py_s
     std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > *ptr = (std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vinteger2d_t___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vinteger2d_T___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_t___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_T___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > const &""'"); 
     }
     arg3 = ptr;
   }
@@ -14374,7 +14374,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -14385,12 +14385,12 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setitem____SWIG_1(PyObject *self, Py_s
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -14408,7 +14408,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -14419,12 +14419,12 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___delitem____SWIG_1(PyObject *self, Py_s
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___delitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___delitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -14442,13 +14442,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___delitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___delitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_t___delitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_T___delitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -14459,7 +14459,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___delitem__(PyObject *self, PyObject *ar
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vinteger2d_t___delitem____SWIG_1(self, argc, argv);
+        return _wrap_vinteger2d_T___delitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -14473,13 +14473,13 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___delitem__(PyObject *self, PyObject *ar
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vinteger2d_t___delitem____SWIG_0(self, argc, argv);
+        return _wrap_vinteger2d_T___delitem____SWIG_0(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_t___delitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_T___delitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< int > >::__delitem__(std::vector< std::vector< int > >::difference_type)\n"
     "    std::vector< std::vector< int > >::__delitem__(SWIGPY_SLICEOBJECT *)\n");
@@ -14487,7 +14487,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::difference_type arg2 ;
@@ -14501,12 +14501,12 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___getitem____SWIG_1(PyObject *self, Py_s
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___getitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___getitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_t___getitem__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_T___getitem__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< int > >::difference_type >(val2);
   try {
@@ -14522,13 +14522,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___getitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___getitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_t___getitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_T___getitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -14539,7 +14539,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___getitem__(PyObject *self, PyObject *ar
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vinteger2d_t___getitem____SWIG_0(self, argc, argv);
+        return _wrap_vinteger2d_T___getitem____SWIG_0(self, argc, argv);
       }
     }
   }
@@ -14553,13 +14553,13 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___getitem__(PyObject *self, PyObject *ar
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vinteger2d_t___getitem____SWIG_1(self, argc, argv);
+        return _wrap_vinteger2d_T___getitem____SWIG_1(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_t___getitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_T___getitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< int > >::__getitem__(SWIGPY_SLICEOBJECT *)\n"
     "    std::vector< std::vector< int > >::__getitem__(std::vector< std::vector< int > >::difference_type) const\n");
@@ -14567,7 +14567,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::difference_type arg2 ;
@@ -14582,22 +14582,22 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setitem____SWIG_2(PyObject *self, Py_s
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_t___setitem__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_T___setitem__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< int > >::difference_type >(val2);
   {
     std::vector< int,std::allocator< int > > *ptr = (std::vector< int,std::allocator< int > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vinteger2d_t___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vinteger2d_T___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_t___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_T___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -14615,13 +14615,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___setitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___setitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_t___setitem__", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_T___setitem__", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -14632,7 +14632,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setitem__(PyObject *self, PyObject *ar
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vinteger2d_t___setitem____SWIG_1(self, argc, argv);
+        return _wrap_vinteger2d_T___setitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -14648,7 +14648,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setitem__(PyObject *self, PyObject *ar
         int res = swig::asptr(argv[2], (std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vinteger2d_t___setitem____SWIG_0(self, argc, argv);
+          return _wrap_vinteger2d_T___setitem____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -14666,14 +14666,14 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setitem__(PyObject *self, PyObject *ar
         int res = swig::asptr(argv[2], (std::vector< int,std::allocator< int > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vinteger2d_t___setitem____SWIG_2(self, argc, argv);
+          return _wrap_vinteger2d_T___setitem____SWIG_2(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_t___setitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_T___setitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< int > >::__setitem__(SWIGPY_SLICEOBJECT *,std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > const &)\n"
     "    std::vector< std::vector< int > >::__setitem__(SWIGPY_SLICEOBJECT *)\n"
@@ -14682,7 +14682,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_pop(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_pop(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -14695,7 +14695,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_pop(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_pop" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_pop" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   try {
@@ -14710,7 +14710,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_append(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_append(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::value_type *arg2 = 0 ;
@@ -14720,20 +14720,20 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_append(PyObject *self, PyObject *args) {
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_t_append", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_T_append", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_append" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_append" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   {
     std::vector< int,std::allocator< int > > *ptr = (std::vector< int,std::allocator< int > > *)0;
     res2 = swig::asptr(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vinteger2d_t_append" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vinteger2d_T_append" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_t_append" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_T_append" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -14747,7 +14747,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vinteger2d_t__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
+SWIGINTERN PyObject *_wrap_new_vinteger2d_T__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *result = 0 ;
   
@@ -14761,7 +14761,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vinteger2d_t__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vinteger2d_T__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int,std::allocator< int > > > *arg1 = 0 ;
   int res1 = SWIG_OLDOBJ ;
@@ -14773,10 +14773,10 @@ SWIGINTERN PyObject *_wrap_new_vinteger2d_t__SWIG_1(PyObject *self, Py_ssize_t n
     std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > *ptr = (std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > *)0;
     res1 = swig::asptr(swig_obj[0], &ptr);
     if (!SWIG_IsOK(res1)) {
-      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vinteger2d_t" "', argument " "1"" of type '" "std::vector< std::vector< int,std::allocator< int > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vinteger2d_T" "', argument " "1"" of type '" "std::vector< std::vector< int,std::allocator< int > > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vinteger2d_t" "', argument " "1"" of type '" "std::vector< std::vector< int,std::allocator< int > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vinteger2d_T" "', argument " "1"" of type '" "std::vector< std::vector< int,std::allocator< int > > > const &""'"); 
     }
     arg1 = ptr;
   }
@@ -14790,7 +14790,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_empty(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_empty(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -14803,7 +14803,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_empty(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_empty" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_empty" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = (bool)((std::vector< std::vector< int > > const *)arg1)->empty();
@@ -14814,7 +14814,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_size(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_size(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -14827,7 +14827,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_size(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_size" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_size" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = ((std::vector< std::vector< int > > const *)arg1)->size();
@@ -14838,7 +14838,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_swap(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_swap(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int,std::allocator< int > > > *arg2 = 0 ;
@@ -14849,18 +14849,18 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_swap(PyObject *self, PyObject *args) {
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_t_swap", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_T_swap", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_swap" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_swap" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], &argp2, SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t,  0 );
   if (!SWIG_IsOK(res2)) {
-    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vinteger2d_t_swap" "', argument " "2"" of type '" "std::vector< std::vector< int,std::allocator< int > > > &""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vinteger2d_T_swap" "', argument " "2"" of type '" "std::vector< std::vector< int,std::allocator< int > > > &""'"); 
   }
   if (!argp2) {
-    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_t_swap" "', argument " "2"" of type '" "std::vector< std::vector< int,std::allocator< int > > > &""'"); 
+    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_T_swap" "', argument " "2"" of type '" "std::vector< std::vector< int,std::allocator< int > > > &""'"); 
   }
   arg2 = reinterpret_cast< std::vector< std::vector< int,std::allocator< int > > > * >(argp2);
   (arg1)->swap(*arg2);
@@ -14871,7 +14871,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_begin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_begin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -14884,7 +14884,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_begin(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_begin" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_begin" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = (arg1)->begin();
@@ -14896,7 +14896,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_end(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_end(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -14909,7 +14909,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_end(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_end" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_end" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = (arg1)->end();
@@ -14921,7 +14921,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_rbegin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_rbegin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -14934,7 +14934,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_rbegin(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_rbegin" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_rbegin" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = (arg1)->rbegin();
@@ -14946,7 +14946,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_rend(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_rend(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -14959,7 +14959,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_rend(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_rend" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_rend" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = (arg1)->rend();
@@ -14971,7 +14971,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_clear(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_clear(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -14983,7 +14983,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_clear(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_clear" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_clear" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   (arg1)->clear();
@@ -14994,7 +14994,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_get_allocator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_get_allocator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -15007,7 +15007,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_get_allocator(PyObject *self, PyObject *
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_get_allocator" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_get_allocator" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = ((std::vector< std::vector< int > > const *)arg1)->get_allocator();
@@ -15018,7 +15018,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vinteger2d_t__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vinteger2d_T__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > >::size_type arg1 ;
   size_t val1 ;
@@ -15029,7 +15029,7 @@ SWIGINTERN PyObject *_wrap_new_vinteger2d_t__SWIG_2(PyObject *self, Py_ssize_t n
   if ((nobjs < 1) || (nobjs > 1)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vinteger2d_t" "', argument " "1"" of type '" "std::vector< std::vector< int > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vinteger2d_T" "', argument " "1"" of type '" "std::vector< std::vector< int > >::size_type""'");
   } 
   arg1 = static_cast< std::vector< std::vector< int > >::size_type >(val1);
   result = (std::vector< std::vector< int > > *)new std::vector< std::vector< int > >(arg1);
@@ -15040,7 +15040,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_pop_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_pop_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -15052,7 +15052,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_pop_back(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_pop_back" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_pop_back" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   (arg1)->pop_back();
@@ -15063,7 +15063,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::size_type arg2 ;
@@ -15076,12 +15076,12 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_resize__SWIG_0(PyObject *self, Py_ssize_
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_resize" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_resize" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_t_resize" "', argument " "2"" of type '" "std::vector< std::vector< int > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_T_resize" "', argument " "2"" of type '" "std::vector< std::vector< int > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< int > >::size_type >(val2);
   (arg1)->resize(arg2);
@@ -15092,7 +15092,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::iterator arg2 ;
@@ -15106,18 +15106,18 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_erase__SWIG_0(PyObject *self, Py_ssize_t
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_erase" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_erase" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t_erase" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T_erase" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t_erase" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T_erase" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
     }
   }
   result = std_vector_Sl_std_vector_Sl_int_Sg__Sg__erase__SWIG_0(arg1,SWIG_STD_MOVE(arg2));
@@ -15129,7 +15129,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::iterator arg2 ;
@@ -15146,29 +15146,29 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_erase__SWIG_1(PyObject *self, Py_ssize_t
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_erase" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_erase" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t_erase" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T_erase" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t_erase" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T_erase" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
     }
   }
   res3 = SWIG_ConvertPtr(swig_obj[2], SWIG_as_voidptrptr(&iter3), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res3) || !iter3) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t_erase" "', argument " "3"" of type '" "std::vector< std::vector< int > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T_erase" "', argument " "3"" of type '" "std::vector< std::vector< int > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *>(iter3);
     if (iter_t) {
       arg3 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t_erase" "', argument " "3"" of type '" "std::vector< std::vector< int > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T_erase" "', argument " "3"" of type '" "std::vector< std::vector< int > >::iterator""'");
     }
   }
   result = std_vector_Sl_std_vector_Sl_int_Sg__Sg__erase__SWIG_1(arg1,SWIG_STD_MOVE(arg2),SWIG_STD_MOVE(arg3));
@@ -15180,13 +15180,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_erase(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_erase(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_t_erase", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_T_erase", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -15197,7 +15197,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_erase(PyObject *self, PyObject *args) {
       int res = SWIG_ConvertPtr(argv[1], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
       _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *>(iter) != 0));
       if (_v) {
-        return _wrap_vinteger2d_t_erase__SWIG_0(self, argc, argv);
+        return _wrap_vinteger2d_T_erase__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -15214,14 +15214,14 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_erase(PyObject *self, PyObject *args) {
         int res = SWIG_ConvertPtr(argv[2], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
         _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *>(iter) != 0));
         if (_v) {
-          return _wrap_vinteger2d_t_erase__SWIG_1(self, argc, argv);
+          return _wrap_vinteger2d_T_erase__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_t_erase'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_T_erase'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< int > >::erase(std::vector< std::vector< int > >::iterator)\n"
     "    std::vector< std::vector< int > >::erase(std::vector< std::vector< int > >::iterator,std::vector< std::vector< int > >::iterator)\n");
@@ -15229,7 +15229,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vinteger2d_t__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vinteger2d_T__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > >::size_type arg1 ;
   std::vector< std::vector< int > >::value_type *arg2 = 0 ;
@@ -15242,17 +15242,17 @@ SWIGINTERN PyObject *_wrap_new_vinteger2d_t__SWIG_3(PyObject *self, Py_ssize_t n
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vinteger2d_t" "', argument " "1"" of type '" "std::vector< std::vector< int > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vinteger2d_T" "', argument " "1"" of type '" "std::vector< std::vector< int > >::size_type""'");
   } 
   arg1 = static_cast< std::vector< std::vector< int > >::size_type >(val1);
   {
     std::vector< int,std::allocator< int > > *ptr = (std::vector< int,std::allocator< int > > *)0;
     res2 = swig::asptr(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "new_vinteger2d_t" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "new_vinteger2d_T" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vinteger2d_t" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vinteger2d_T" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -15266,16 +15266,16 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vinteger2d_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_new_vinteger2d_T(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vinteger2d_t", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vinteger2d_T", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 0) {
-    return _wrap_new_vinteger2d_t__SWIG_0(self, argc, argv);
+    return _wrap_new_vinteger2d_T__SWIG_0(self, argc, argv);
   }
   if (argc == 1) {
     int _v = 0;
@@ -15284,7 +15284,7 @@ SWIGINTERN PyObject *_wrap_new_vinteger2d_t(PyObject *self, PyObject *args) {
       _v = SWIG_CheckState(res);
     }
     if (_v) {
-      return _wrap_new_vinteger2d_t__SWIG_2(self, argc, argv);
+      return _wrap_new_vinteger2d_T__SWIG_2(self, argc, argv);
     }
   }
   if (argc == 1) {
@@ -15292,7 +15292,7 @@ SWIGINTERN PyObject *_wrap_new_vinteger2d_t(PyObject *self, PyObject *args) {
     int res = swig::asptr(argv[0], (std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > >**)(0));
     _v = SWIG_CheckState(res);
     if (_v) {
-      return _wrap_new_vinteger2d_t__SWIG_1(self, argc, argv);
+      return _wrap_new_vinteger2d_T__SWIG_1(self, argc, argv);
     }
   }
   if (argc == 2) {
@@ -15305,13 +15305,13 @@ SWIGINTERN PyObject *_wrap_new_vinteger2d_t(PyObject *self, PyObject *args) {
       int res = swig::asptr(argv[1], (std::vector< int,std::allocator< int > >**)(0));
       _v = SWIG_CheckState(res);
       if (_v) {
-        return _wrap_new_vinteger2d_t__SWIG_3(self, argc, argv);
+        return _wrap_new_vinteger2d_T__SWIG_3(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vinteger2d_t'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vinteger2d_T'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< int > >::vector()\n"
     "    std::vector< std::vector< int > >::vector(std::vector< std::vector< int,std::allocator< int > > > const &)\n"
@@ -15321,7 +15321,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_push_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_push_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::value_type *arg2 = 0 ;
@@ -15331,20 +15331,20 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_push_back(PyObject *self, PyObject *args
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_t_push_back", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_T_push_back", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_push_back" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_push_back" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   {
     std::vector< int,std::allocator< int > > *ptr = (std::vector< int,std::allocator< int > > *)0;
     res2 = swig::asptr(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vinteger2d_t_push_back" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vinteger2d_T_push_back" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_t_push_back" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_T_push_back" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -15358,7 +15358,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_front(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_front(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -15371,7 +15371,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_front(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_front" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_front" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = (std::vector< std::vector< int > >::value_type *) &((std::vector< std::vector< int > > const *)arg1)->front();
@@ -15383,7 +15383,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -15396,7 +15396,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_back(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_back" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_back" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = (std::vector< std::vector< int > >::value_type *) &((std::vector< std::vector< int > > const *)arg1)->back();
@@ -15408,7 +15408,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_assign(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_assign(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::size_type arg2 ;
@@ -15421,25 +15421,25 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_assign(PyObject *self, PyObject *args) {
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_t_assign", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_T_assign", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_assign" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_assign" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_t_assign" "', argument " "2"" of type '" "std::vector< std::vector< int > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_T_assign" "', argument " "2"" of type '" "std::vector< std::vector< int > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< int > >::size_type >(val2);
   {
     std::vector< int,std::allocator< int > > *ptr = (std::vector< int,std::allocator< int > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vinteger2d_t_assign" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vinteger2d_T_assign" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_t_assign" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_T_assign" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -15453,7 +15453,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::size_type arg2 ;
@@ -15468,22 +15468,22 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_resize__SWIG_1(PyObject *self, Py_ssize_
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_resize" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_resize" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_t_resize" "', argument " "2"" of type '" "std::vector< std::vector< int > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_T_resize" "', argument " "2"" of type '" "std::vector< std::vector< int > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< int > >::size_type >(val2);
   {
     std::vector< int,std::allocator< int > > *ptr = (std::vector< int,std::allocator< int > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vinteger2d_t_resize" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vinteger2d_T_resize" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_t_resize" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_T_resize" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -15497,13 +15497,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_resize(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_resize(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_t_resize", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_T_resize", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -15515,7 +15515,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_resize(PyObject *self, PyObject *args) {
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vinteger2d_t_resize__SWIG_0(self, argc, argv);
+        return _wrap_vinteger2d_T_resize__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -15532,14 +15532,14 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_resize(PyObject *self, PyObject *args) {
         int res = swig::asptr(argv[2], (std::vector< int,std::allocator< int > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vinteger2d_t_resize__SWIG_1(self, argc, argv);
+          return _wrap_vinteger2d_T_resize__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_t_resize'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_T_resize'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< int > >::resize(std::vector< std::vector< int > >::size_type)\n"
     "    std::vector< std::vector< int > >::resize(std::vector< std::vector< int > >::size_type,std::vector< std::vector< int > >::value_type const &)\n");
@@ -15547,7 +15547,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::iterator arg2 ;
@@ -15563,28 +15563,28 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_insert__SWIG_0(PyObject *self, Py_ssize_
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_insert" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_insert" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t_insert" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T_insert" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t_insert" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T_insert" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
     }
   }
   {
     std::vector< int,std::allocator< int > > *ptr = (std::vector< int,std::allocator< int > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vinteger2d_t_insert" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vinteger2d_T_insert" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_t_insert" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_T_insert" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -15599,7 +15599,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::iterator arg2 ;
@@ -15617,33 +15617,33 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_insert__SWIG_1(PyObject *self, Py_ssize_
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_insert" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_insert" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t_insert" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T_insert" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t_insert" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T_insert" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_size_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vinteger2d_t_insert" "', argument " "3"" of type '" "std::vector< std::vector< int > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vinteger2d_T_insert" "', argument " "3"" of type '" "std::vector< std::vector< int > >::size_type""'");
   } 
   arg3 = static_cast< std::vector< std::vector< int > >::size_type >(val3);
   {
     std::vector< int,std::allocator< int > > *ptr = (std::vector< int,std::allocator< int > > *)0;
     res4 = swig::asptr(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vinteger2d_t_insert" "', argument " "4"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vinteger2d_T_insert" "', argument " "4"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_t_insert" "', argument " "4"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_T_insert" "', argument " "4"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     arg4 = ptr;
   }
@@ -15657,13 +15657,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_insert(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_insert(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_t_insert", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_T_insert", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -15677,7 +15677,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_insert(PyObject *self, PyObject *args) {
         int res = swig::asptr(argv[2], (std::vector< int,std::allocator< int > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vinteger2d_t_insert__SWIG_0(self, argc, argv);
+          return _wrap_vinteger2d_T_insert__SWIG_0(self, argc, argv);
         }
       }
     }
@@ -15699,7 +15699,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_insert(PyObject *self, PyObject *args) {
           int res = swig::asptr(argv[3], (std::vector< int,std::allocator< int > >**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vinteger2d_t_insert__SWIG_1(self, argc, argv);
+            return _wrap_vinteger2d_T_insert__SWIG_1(self, argc, argv);
           }
         }
       }
@@ -15707,7 +15707,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_insert(PyObject *self, PyObject *args) {
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_t_insert'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_T_insert'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< int > >::insert(std::vector< std::vector< int > >::iterator,std::vector< std::vector< int > >::value_type const &)\n"
     "    std::vector< std::vector< int > >::insert(std::vector< std::vector< int > >::iterator,std::vector< std::vector< int > >::size_type,std::vector< std::vector< int > >::value_type const &)\n");
@@ -15715,7 +15715,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_reserve(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_reserve(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::size_type arg2 ;
@@ -15726,15 +15726,15 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_reserve(PyObject *self, PyObject *args)
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_t_reserve", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_T_reserve", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_reserve" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_reserve" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_t_reserve" "', argument " "2"" of type '" "std::vector< std::vector< int > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_T_reserve" "', argument " "2"" of type '" "std::vector< std::vector< int > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< int > >::size_type >(val2);
   (arg1)->reserve(arg2);
@@ -15745,7 +15745,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_capacity(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_capacity(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -15758,7 +15758,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_capacity(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_capacity" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_capacity" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = ((std::vector< std::vector< int > > const *)arg1)->capacity();
@@ -15769,7 +15769,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_delete_vinteger2d_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_delete_vinteger2d_T(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -15781,7 +15781,7 @@ SWIGINTERN PyObject *_wrap_delete_vinteger2d_t(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, SWIG_POINTER_DISOWN |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vinteger2d_t" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vinteger2d_T" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   {
@@ -15802,18 +15802,18 @@ fail:
 }
 
 
-SWIGINTERN PyObject *vinteger2d_t_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vinteger2d_T_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   PyObject *obj;
   if (!SWIG_Python_UnpackTuple(args, "swigregister", 1, 1, &obj)) return NULL;
   SWIG_TypeNewClientData(SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, SWIG_NewClientData(obj));
   return SWIG_Py_Void();
 }
 
-SWIGINTERN PyObject *vinteger2d_t_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vinteger2d_T_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   return SWIG_Python_InitShadowInstance(args);
 }
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_iterator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_iterator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   PyObject **arg2 = (PyObject **) 0 ;
@@ -15828,7 +15828,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_iterator(PyObject *self, PyObjec
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_iterator" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_iterator" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = (swig::SwigPyIterator *)std_vector_Sl_unsigned_SS_long_Sg__iterator(arg1,arg2);
@@ -15839,7 +15839,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___nonzero__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___nonzero__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -15852,7 +15852,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___nonzero__(PyObject *self, PyOb
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___nonzero__" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___nonzero__" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = (bool)std_vector_Sl_unsigned_SS_long_Sg____nonzero__((std::vector< unsigned long > const *)arg1);
@@ -15863,7 +15863,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___bool__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___bool__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -15876,7 +15876,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___bool__(PyObject *self, PyObjec
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___bool__" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___bool__" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = (bool)std_vector_Sl_unsigned_SS_long_Sg____bool__((std::vector< unsigned long > const *)arg1);
@@ -15887,7 +15887,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___len__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___len__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -15900,7 +15900,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___len__(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___len__" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___len__" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = std_vector_Sl_unsigned_SS_long_Sg____len__((std::vector< unsigned long > const *)arg1);
@@ -15911,7 +15911,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___getslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___getslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::difference_type arg2 ;
@@ -15926,20 +15926,20 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___getslice__(PyObject *self, PyO
   std::vector< unsigned long,std::allocator< unsigned long > > *result = 0 ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_t___getslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_T___getslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___getslice__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___getslice__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t___getslice__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T___getslice__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< unsigned long >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_t___getslice__" "', argument " "3"" of type '" "std::vector< unsigned long >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_T___getslice__" "', argument " "3"" of type '" "std::vector< unsigned long >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< unsigned long >::difference_type >(val3);
   try {
@@ -15956,7 +15956,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::difference_type arg2 ;
@@ -15972,17 +15972,17 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setslice____SWIG_0(PyObject *s
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___setslice__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___setslice__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t___setslice__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T___setslice__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< unsigned long >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_t___setslice__" "', argument " "3"" of type '" "std::vector< unsigned long >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_T___setslice__" "', argument " "3"" of type '" "std::vector< unsigned long >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< unsigned long >::difference_type >(val3);
   try {
@@ -15999,7 +15999,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::difference_type arg2 ;
@@ -16017,27 +16017,27 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setslice____SWIG_1(PyObject *s
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___setslice__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___setslice__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t___setslice__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T___setslice__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< unsigned long >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_t___setslice__" "', argument " "3"" of type '" "std::vector< unsigned long >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_T___setslice__" "', argument " "3"" of type '" "std::vector< unsigned long >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< unsigned long >::difference_type >(val3);
   {
     std::vector< unsigned long,std::allocator< unsigned long > > *ptr = (std::vector< unsigned long,std::allocator< unsigned long > > *)0;
     res4 = swig::asptr(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_longinteger_t___setslice__" "', argument " "4"" of type '" "std::vector< unsigned long,std::allocator< unsigned long > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_longinteger_T___setslice__" "', argument " "4"" of type '" "std::vector< unsigned long,std::allocator< unsigned long > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_longinteger_t___setslice__" "', argument " "4"" of type '" "std::vector< unsigned long,std::allocator< unsigned long > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_longinteger_T___setslice__" "', argument " "4"" of type '" "std::vector< unsigned long,std::allocator< unsigned long > > const &""'"); 
     }
     arg4 = ptr;
   }
@@ -16057,13 +16057,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___setslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___setslice__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_t___setslice__", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_T___setslice__", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -16080,7 +16080,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setslice__(PyObject *self, PyO
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_longinteger_t___setslice____SWIG_0(self, argc, argv);
+          return _wrap_vector_longinteger_T___setslice____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -16103,7 +16103,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setslice__(PyObject *self, PyO
           int res = swig::asptr(argv[3], (std::vector< unsigned long,std::allocator< unsigned long > >**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vector_longinteger_t___setslice____SWIG_1(self, argc, argv);
+            return _wrap_vector_longinteger_T___setslice____SWIG_1(self, argc, argv);
           }
         }
       }
@@ -16111,7 +16111,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setslice__(PyObject *self, PyO
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_t___setslice__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_T___setslice__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< unsigned long >::__setslice__(std::vector< unsigned long >::difference_type,std::vector< unsigned long >::difference_type)\n"
     "    std::vector< unsigned long >::__setslice__(std::vector< unsigned long >::difference_type,std::vector< unsigned long >::difference_type,std::vector< unsigned long,std::allocator< unsigned long > > const &)\n");
@@ -16119,7 +16119,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___delslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___delslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::difference_type arg2 ;
@@ -16133,20 +16133,20 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___delslice__(PyObject *self, PyO
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_t___delslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_T___delslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___delslice__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___delslice__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t___delslice__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T___delslice__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< unsigned long >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_t___delslice__" "', argument " "3"" of type '" "std::vector< unsigned long >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_T___delslice__" "', argument " "3"" of type '" "std::vector< unsigned long >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< unsigned long >::difference_type >(val3);
   try {
@@ -16163,7 +16163,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::difference_type arg2 ;
@@ -16176,12 +16176,12 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___delitem____SWIG_0(PyObject *se
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___delitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___delitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t___delitem__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T___delitem__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< unsigned long >::difference_type >(val2);
   try {
@@ -16198,7 +16198,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -16210,12 +16210,12 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___getitem____SWIG_0(PyObject *se
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___getitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___getitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -16233,7 +16233,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -16246,12 +16246,12 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setitem____SWIG_0(PyObject *se
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___setitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___setitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -16259,10 +16259,10 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setitem____SWIG_0(PyObject *se
     std::vector< unsigned long,std::allocator< unsigned long > > *ptr = (std::vector< unsigned long,std::allocator< unsigned long > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_longinteger_t___setitem__" "', argument " "3"" of type '" "std::vector< unsigned long,std::allocator< unsigned long > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_longinteger_T___setitem__" "', argument " "3"" of type '" "std::vector< unsigned long,std::allocator< unsigned long > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_longinteger_t___setitem__" "', argument " "3"" of type '" "std::vector< unsigned long,std::allocator< unsigned long > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_longinteger_T___setitem__" "', argument " "3"" of type '" "std::vector< unsigned long,std::allocator< unsigned long > > const &""'"); 
     }
     arg3 = ptr;
   }
@@ -16282,7 +16282,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -16293,12 +16293,12 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setitem____SWIG_1(PyObject *se
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___setitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___setitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -16316,7 +16316,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -16327,12 +16327,12 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___delitem____SWIG_1(PyObject *se
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___delitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___delitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -16350,13 +16350,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___delitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___delitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_t___delitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_T___delitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -16367,7 +16367,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___delitem__(PyObject *self, PyOb
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_longinteger_t___delitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_longinteger_T___delitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -16381,13 +16381,13 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___delitem__(PyObject *self, PyOb
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_longinteger_t___delitem____SWIG_0(self, argc, argv);
+        return _wrap_vector_longinteger_T___delitem____SWIG_0(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_t___delitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_T___delitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< unsigned long >::__delitem__(std::vector< unsigned long >::difference_type)\n"
     "    std::vector< unsigned long >::__delitem__(SWIGPY_SLICEOBJECT *)\n");
@@ -16395,7 +16395,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::difference_type arg2 ;
@@ -16409,12 +16409,12 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___getitem____SWIG_1(PyObject *se
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___getitem__" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___getitem__" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t___getitem__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T___getitem__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< unsigned long >::difference_type >(val2);
   try {
@@ -16430,13 +16430,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___getitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___getitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_t___getitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_T___getitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -16447,7 +16447,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___getitem__(PyObject *self, PyOb
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_longinteger_t___getitem____SWIG_0(self, argc, argv);
+        return _wrap_vector_longinteger_T___getitem____SWIG_0(self, argc, argv);
       }
     }
   }
@@ -16461,13 +16461,13 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___getitem__(PyObject *self, PyOb
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_longinteger_t___getitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_longinteger_T___getitem____SWIG_1(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_t___getitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_T___getitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< unsigned long >::__getitem__(SWIGPY_SLICEOBJECT *)\n"
     "    std::vector< unsigned long >::__getitem__(std::vector< unsigned long >::difference_type) const\n");
@@ -16475,7 +16475,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::difference_type arg2 ;
@@ -16492,17 +16492,17 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setitem____SWIG_2(PyObject *se
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___setitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___setitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t___setitem__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T___setitem__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< unsigned long >::difference_type >(val2);
   ecode3 = SWIG_AsVal_unsigned_SS_long(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_t___setitem__" "', argument " "3"" of type '" "std::vector< unsigned long >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_T___setitem__" "', argument " "3"" of type '" "std::vector< unsigned long >::value_type""'");
   } 
   temp3 = static_cast< std::vector< unsigned long >::value_type >(val3);
   arg3 = &temp3;
@@ -16518,13 +16518,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___setitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___setitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_t___setitem__", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_T___setitem__", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -16535,7 +16535,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setitem__(PyObject *self, PyOb
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_longinteger_t___setitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_longinteger_T___setitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -16551,7 +16551,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setitem__(PyObject *self, PyOb
         int res = swig::asptr(argv[2], (std::vector< unsigned long,std::allocator< unsigned long > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vector_longinteger_t___setitem____SWIG_0(self, argc, argv);
+          return _wrap_vector_longinteger_T___setitem____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -16571,14 +16571,14 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setitem__(PyObject *self, PyOb
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_longinteger_t___setitem____SWIG_2(self, argc, argv);
+          return _wrap_vector_longinteger_T___setitem____SWIG_2(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_t___setitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_T___setitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< unsigned long >::__setitem__(SWIGPY_SLICEOBJECT *,std::vector< unsigned long,std::allocator< unsigned long > > const &)\n"
     "    std::vector< unsigned long >::__setitem__(SWIGPY_SLICEOBJECT *)\n"
@@ -16587,7 +16587,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_pop(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_pop(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -16600,7 +16600,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_pop(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_pop" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_pop" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   try {
@@ -16615,7 +16615,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_append(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_append(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::value_type *arg2 = 0 ;
@@ -16627,15 +16627,15 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_append(PyObject *self, PyObject
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_t_append", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_T_append", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_append" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_append" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_unsigned_SS_long(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t_append" "', argument " "2"" of type '" "std::vector< unsigned long >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T_append" "', argument " "2"" of type '" "std::vector< unsigned long >::value_type""'");
   } 
   temp2 = static_cast< std::vector< unsigned long >::value_type >(val2);
   arg2 = &temp2;
@@ -16647,7 +16647,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_longinteger_t__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
+SWIGINTERN PyObject *_wrap_new_vector_longinteger_T__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *result = 0 ;
   
@@ -16661,7 +16661,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_longinteger_t__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_longinteger_T__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = 0 ;
   int res1 = SWIG_OLDOBJ ;
@@ -16673,10 +16673,10 @@ SWIGINTERN PyObject *_wrap_new_vector_longinteger_t__SWIG_1(PyObject *self, Py_s
     std::vector< unsigned long,std::allocator< unsigned long > > *ptr = (std::vector< unsigned long,std::allocator< unsigned long > > *)0;
     res1 = swig::asptr(swig_obj[0], &ptr);
     if (!SWIG_IsOK(res1)) {
-      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vector_longinteger_t" "', argument " "1"" of type '" "std::vector< unsigned long > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vector_longinteger_T" "', argument " "1"" of type '" "std::vector< unsigned long > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_longinteger_t" "', argument " "1"" of type '" "std::vector< unsigned long > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_longinteger_T" "', argument " "1"" of type '" "std::vector< unsigned long > const &""'"); 
     }
     arg1 = ptr;
   }
@@ -16690,7 +16690,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_empty(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_empty(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -16703,7 +16703,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_empty(PyObject *self, PyObject *
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_empty" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_empty" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = (bool)((std::vector< unsigned long > const *)arg1)->empty();
@@ -16714,7 +16714,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_size(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_size(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -16727,7 +16727,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_size(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_size" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_size" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = ((std::vector< unsigned long > const *)arg1)->size();
@@ -16738,7 +16738,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_swap(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_swap(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long > *arg2 = 0 ;
@@ -16749,18 +16749,18 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_swap(PyObject *self, PyObject *a
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_t_swap", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_T_swap", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_swap" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_swap" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], &argp2, SWIGTYPE_p_std__vectorT_unsigned_long_t,  0 );
   if (!SWIG_IsOK(res2)) {
-    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_longinteger_t_swap" "', argument " "2"" of type '" "std::vector< unsigned long > &""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_longinteger_T_swap" "', argument " "2"" of type '" "std::vector< unsigned long > &""'"); 
   }
   if (!argp2) {
-    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_longinteger_t_swap" "', argument " "2"" of type '" "std::vector< unsigned long > &""'"); 
+    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_longinteger_T_swap" "', argument " "2"" of type '" "std::vector< unsigned long > &""'"); 
   }
   arg2 = reinterpret_cast< std::vector< unsigned long > * >(argp2);
   (arg1)->swap(*arg2);
@@ -16771,7 +16771,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_begin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_begin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -16784,7 +16784,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_begin(PyObject *self, PyObject *
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_begin" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_begin" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = (arg1)->begin();
@@ -16796,7 +16796,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_end(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_end(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -16809,7 +16809,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_end(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_end" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_end" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = (arg1)->end();
@@ -16821,7 +16821,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_rbegin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_rbegin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -16834,7 +16834,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_rbegin(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_rbegin" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_rbegin" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = (arg1)->rbegin();
@@ -16846,7 +16846,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_rend(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_rend(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -16859,7 +16859,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_rend(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_rend" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_rend" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = (arg1)->rend();
@@ -16871,7 +16871,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_clear(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_clear(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -16883,7 +16883,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_clear(PyObject *self, PyObject *
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_clear" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_clear" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   (arg1)->clear();
@@ -16894,7 +16894,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_get_allocator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_get_allocator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -16907,7 +16907,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_get_allocator(PyObject *self, Py
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_get_allocator" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_get_allocator" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = ((std::vector< unsigned long > const *)arg1)->get_allocator();
@@ -16918,7 +16918,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_longinteger_t__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_longinteger_T__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long >::size_type arg1 ;
   size_t val1 ;
@@ -16929,7 +16929,7 @@ SWIGINTERN PyObject *_wrap_new_vector_longinteger_t__SWIG_2(PyObject *self, Py_s
   if ((nobjs < 1) || (nobjs > 1)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_longinteger_t" "', argument " "1"" of type '" "std::vector< unsigned long >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_longinteger_T" "', argument " "1"" of type '" "std::vector< unsigned long >::size_type""'");
   } 
   arg1 = static_cast< std::vector< unsigned long >::size_type >(val1);
   result = (std::vector< unsigned long > *)new std::vector< unsigned long >(arg1);
@@ -16940,7 +16940,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_pop_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_pop_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -16952,7 +16952,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_pop_back(PyObject *self, PyObjec
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_pop_back" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_pop_back" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   (arg1)->pop_back();
@@ -16963,7 +16963,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::size_type arg2 ;
@@ -16976,12 +16976,12 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_resize__SWIG_0(PyObject *self, P
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_resize" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_resize" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t_resize" "', argument " "2"" of type '" "std::vector< unsigned long >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T_resize" "', argument " "2"" of type '" "std::vector< unsigned long >::size_type""'");
   } 
   arg2 = static_cast< std::vector< unsigned long >::size_type >(val2);
   (arg1)->resize(arg2);
@@ -16992,7 +16992,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::iterator arg2 ;
@@ -17006,18 +17006,18 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_erase__SWIG_0(PyObject *self, Py
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_erase" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_erase" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t_erase" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T_erase" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t_erase" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T_erase" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
     }
   }
   result = std_vector_Sl_unsigned_SS_long_Sg__erase__SWIG_0(arg1,SWIG_STD_MOVE(arg2));
@@ -17029,7 +17029,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::iterator arg2 ;
@@ -17046,29 +17046,29 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_erase__SWIG_1(PyObject *self, Py
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_erase" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_erase" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t_erase" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T_erase" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t_erase" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T_erase" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
     }
   }
   res3 = SWIG_ConvertPtr(swig_obj[2], SWIG_as_voidptrptr(&iter3), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res3) || !iter3) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t_erase" "', argument " "3"" of type '" "std::vector< unsigned long >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T_erase" "', argument " "3"" of type '" "std::vector< unsigned long >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *>(iter3);
     if (iter_t) {
       arg3 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t_erase" "', argument " "3"" of type '" "std::vector< unsigned long >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T_erase" "', argument " "3"" of type '" "std::vector< unsigned long >::iterator""'");
     }
   }
   result = std_vector_Sl_unsigned_SS_long_Sg__erase__SWIG_1(arg1,SWIG_STD_MOVE(arg2),SWIG_STD_MOVE(arg3));
@@ -17080,13 +17080,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_erase(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_erase(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_t_erase", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_T_erase", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -17097,7 +17097,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_erase(PyObject *self, PyObject *
       int res = SWIG_ConvertPtr(argv[1], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
       _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *>(iter) != 0));
       if (_v) {
-        return _wrap_vector_longinteger_t_erase__SWIG_0(self, argc, argv);
+        return _wrap_vector_longinteger_T_erase__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -17114,14 +17114,14 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_erase(PyObject *self, PyObject *
         int res = SWIG_ConvertPtr(argv[2], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
         _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *>(iter) != 0));
         if (_v) {
-          return _wrap_vector_longinteger_t_erase__SWIG_1(self, argc, argv);
+          return _wrap_vector_longinteger_T_erase__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_t_erase'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_T_erase'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< unsigned long >::erase(std::vector< unsigned long >::iterator)\n"
     "    std::vector< unsigned long >::erase(std::vector< unsigned long >::iterator,std::vector< unsigned long >::iterator)\n");
@@ -17129,7 +17129,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_longinteger_t__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_longinteger_T__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long >::size_type arg1 ;
   std::vector< unsigned long >::value_type *arg2 = 0 ;
@@ -17144,12 +17144,12 @@ SWIGINTERN PyObject *_wrap_new_vector_longinteger_t__SWIG_3(PyObject *self, Py_s
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_longinteger_t" "', argument " "1"" of type '" "std::vector< unsigned long >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_longinteger_T" "', argument " "1"" of type '" "std::vector< unsigned long >::size_type""'");
   } 
   arg1 = static_cast< std::vector< unsigned long >::size_type >(val1);
   ecode2 = SWIG_AsVal_unsigned_SS_long(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "new_vector_longinteger_t" "', argument " "2"" of type '" "std::vector< unsigned long >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "new_vector_longinteger_T" "', argument " "2"" of type '" "std::vector< unsigned long >::value_type""'");
   } 
   temp2 = static_cast< std::vector< unsigned long >::value_type >(val2);
   arg2 = &temp2;
@@ -17161,16 +17161,16 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_longinteger_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_new_vector_longinteger_T(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vector_longinteger_t", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vector_longinteger_T", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 0) {
-    return _wrap_new_vector_longinteger_t__SWIG_0(self, argc, argv);
+    return _wrap_new_vector_longinteger_T__SWIG_0(self, argc, argv);
   }
   if (argc == 1) {
     int _v = 0;
@@ -17179,7 +17179,7 @@ SWIGINTERN PyObject *_wrap_new_vector_longinteger_t(PyObject *self, PyObject *ar
       _v = SWIG_CheckState(res);
     }
     if (_v) {
-      return _wrap_new_vector_longinteger_t__SWIG_2(self, argc, argv);
+      return _wrap_new_vector_longinteger_T__SWIG_2(self, argc, argv);
     }
   }
   if (argc == 1) {
@@ -17187,7 +17187,7 @@ SWIGINTERN PyObject *_wrap_new_vector_longinteger_t(PyObject *self, PyObject *ar
     int res = swig::asptr(argv[0], (std::vector< unsigned long,std::allocator< unsigned long > >**)(0));
     _v = SWIG_CheckState(res);
     if (_v) {
-      return _wrap_new_vector_longinteger_t__SWIG_1(self, argc, argv);
+      return _wrap_new_vector_longinteger_T__SWIG_1(self, argc, argv);
     }
   }
   if (argc == 2) {
@@ -17202,13 +17202,13 @@ SWIGINTERN PyObject *_wrap_new_vector_longinteger_t(PyObject *self, PyObject *ar
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_new_vector_longinteger_t__SWIG_3(self, argc, argv);
+        return _wrap_new_vector_longinteger_T__SWIG_3(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vector_longinteger_t'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vector_longinteger_T'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< unsigned long >::vector()\n"
     "    std::vector< unsigned long >::vector(std::vector< unsigned long > const &)\n"
@@ -17218,7 +17218,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_push_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_push_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::value_type *arg2 = 0 ;
@@ -17230,15 +17230,15 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_push_back(PyObject *self, PyObje
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_t_push_back", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_T_push_back", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_push_back" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_push_back" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_unsigned_SS_long(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t_push_back" "', argument " "2"" of type '" "std::vector< unsigned long >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T_push_back" "', argument " "2"" of type '" "std::vector< unsigned long >::value_type""'");
   } 
   temp2 = static_cast< std::vector< unsigned long >::value_type >(val2);
   arg2 = &temp2;
@@ -17250,7 +17250,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_front(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_front(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -17263,7 +17263,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_front(PyObject *self, PyObject *
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_front" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_front" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = (std::vector< unsigned long >::value_type *) &((std::vector< unsigned long > const *)arg1)->front();
@@ -17275,7 +17275,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -17288,7 +17288,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_back(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_back" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_back" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = (std::vector< unsigned long >::value_type *) &((std::vector< unsigned long > const *)arg1)->back();
@@ -17300,7 +17300,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_assign(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_assign(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::size_type arg2 ;
@@ -17315,20 +17315,20 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_assign(PyObject *self, PyObject
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_t_assign", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_T_assign", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_assign" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_assign" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t_assign" "', argument " "2"" of type '" "std::vector< unsigned long >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T_assign" "', argument " "2"" of type '" "std::vector< unsigned long >::size_type""'");
   } 
   arg2 = static_cast< std::vector< unsigned long >::size_type >(val2);
   ecode3 = SWIG_AsVal_unsigned_SS_long(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_t_assign" "', argument " "3"" of type '" "std::vector< unsigned long >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_T_assign" "', argument " "3"" of type '" "std::vector< unsigned long >::value_type""'");
   } 
   temp3 = static_cast< std::vector< unsigned long >::value_type >(val3);
   arg3 = &temp3;
@@ -17340,7 +17340,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::size_type arg2 ;
@@ -17357,17 +17357,17 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_resize__SWIG_1(PyObject *self, P
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_resize" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_resize" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t_resize" "', argument " "2"" of type '" "std::vector< unsigned long >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T_resize" "', argument " "2"" of type '" "std::vector< unsigned long >::size_type""'");
   } 
   arg2 = static_cast< std::vector< unsigned long >::size_type >(val2);
   ecode3 = SWIG_AsVal_unsigned_SS_long(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_t_resize" "', argument " "3"" of type '" "std::vector< unsigned long >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_T_resize" "', argument " "3"" of type '" "std::vector< unsigned long >::value_type""'");
   } 
   temp3 = static_cast< std::vector< unsigned long >::value_type >(val3);
   arg3 = &temp3;
@@ -17379,13 +17379,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_resize(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_resize(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_t_resize", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_T_resize", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -17397,7 +17397,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_resize(PyObject *self, PyObject
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_longinteger_t_resize__SWIG_0(self, argc, argv);
+        return _wrap_vector_longinteger_T_resize__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -17416,14 +17416,14 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_resize(PyObject *self, PyObject
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_longinteger_t_resize__SWIG_1(self, argc, argv);
+          return _wrap_vector_longinteger_T_resize__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_t_resize'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_T_resize'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< unsigned long >::resize(std::vector< unsigned long >::size_type)\n"
     "    std::vector< unsigned long >::resize(std::vector< unsigned long >::size_type,std::vector< unsigned long >::value_type const &)\n");
@@ -17431,7 +17431,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::iterator arg2 ;
@@ -17449,23 +17449,23 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_insert__SWIG_0(PyObject *self, P
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_insert" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_insert" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t_insert" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T_insert" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t_insert" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T_insert" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_unsigned_SS_long(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_t_insert" "', argument " "3"" of type '" "std::vector< unsigned long >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_T_insert" "', argument " "3"" of type '" "std::vector< unsigned long >::value_type""'");
   } 
   temp3 = static_cast< std::vector< unsigned long >::value_type >(val3);
   arg3 = &temp3;
@@ -17478,7 +17478,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::iterator arg2 ;
@@ -17498,28 +17498,28 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_insert__SWIG_1(PyObject *self, P
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_insert" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_insert" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t_insert" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T_insert" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t_insert" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T_insert" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_size_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_t_insert" "', argument " "3"" of type '" "std::vector< unsigned long >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_T_insert" "', argument " "3"" of type '" "std::vector< unsigned long >::size_type""'");
   } 
   arg3 = static_cast< std::vector< unsigned long >::size_type >(val3);
   ecode4 = SWIG_AsVal_unsigned_SS_long(swig_obj[3], &val4);
   if (!SWIG_IsOK(ecode4)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode4), "in method '" "vector_longinteger_t_insert" "', argument " "4"" of type '" "std::vector< unsigned long >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode4), "in method '" "vector_longinteger_T_insert" "', argument " "4"" of type '" "std::vector< unsigned long >::value_type""'");
   } 
   temp4 = static_cast< std::vector< unsigned long >::value_type >(val4);
   arg4 = &temp4;
@@ -17531,13 +17531,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_insert(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_insert(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_t_insert", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_T_insert", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -17553,7 +17553,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_insert(PyObject *self, PyObject
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_longinteger_t_insert__SWIG_0(self, argc, argv);
+          return _wrap_vector_longinteger_T_insert__SWIG_0(self, argc, argv);
         }
       }
     }
@@ -17577,7 +17577,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_insert(PyObject *self, PyObject
             _v = SWIG_CheckState(res);
           }
           if (_v) {
-            return _wrap_vector_longinteger_t_insert__SWIG_1(self, argc, argv);
+            return _wrap_vector_longinteger_T_insert__SWIG_1(self, argc, argv);
           }
         }
       }
@@ -17585,7 +17585,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_insert(PyObject *self, PyObject
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_t_insert'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_T_insert'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< unsigned long >::insert(std::vector< unsigned long >::iterator,std::vector< unsigned long >::value_type const &)\n"
     "    std::vector< unsigned long >::insert(std::vector< unsigned long >::iterator,std::vector< unsigned long >::size_type,std::vector< unsigned long >::value_type const &)\n");
@@ -17593,7 +17593,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_reserve(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_reserve(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::size_type arg2 ;
@@ -17604,15 +17604,15 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_reserve(PyObject *self, PyObject
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_t_reserve", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_T_reserve", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_reserve" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_reserve" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t_reserve" "', argument " "2"" of type '" "std::vector< unsigned long >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T_reserve" "', argument " "2"" of type '" "std::vector< unsigned long >::size_type""'");
   } 
   arg2 = static_cast< std::vector< unsigned long >::size_type >(val2);
   (arg1)->reserve(arg2);
@@ -17623,7 +17623,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_capacity(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_capacity(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -17636,7 +17636,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_capacity(PyObject *self, PyObjec
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_capacity" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_capacity" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = ((std::vector< unsigned long > const *)arg1)->capacity();
@@ -17647,7 +17647,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_delete_vector_longinteger_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_delete_vector_longinteger_T(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -17659,7 +17659,7 @@ SWIGINTERN PyObject *_wrap_delete_vector_longinteger_t(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, SWIG_POINTER_DISOWN |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vector_longinteger_t" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vector_longinteger_T" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   {
@@ -17680,18 +17680,18 @@ fail:
 }
 
 
-SWIGINTERN PyObject *vector_longinteger_t_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vector_longinteger_T_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   PyObject *obj;
   if (!SWIG_Python_UnpackTuple(args, "swigregister", 1, 1, &obj)) return NULL;
   SWIG_TypeNewClientData(SWIGTYPE_p_std__vectorT_unsigned_long_t, SWIG_NewClientData(obj));
   return SWIG_Py_Void();
 }
 
-SWIGINTERN PyObject *vector_longinteger_t_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vector_longinteger_T_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   return SWIG_Python_InitShadowInstance(args);
 }
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_iterator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_iterator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   PyObject **arg2 = (PyObject **) 0 ;
@@ -17706,7 +17706,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_iterator(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_iterator" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_iterator" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = (swig::SwigPyIterator *)std_vector_Sl_std_complex_Sl_double_Sg__Sg__iterator(arg1,arg2);
@@ -17717,7 +17717,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___nonzero__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___nonzero__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -17730,7 +17730,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___nonzero__(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___nonzero__" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___nonzero__" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = (bool)std_vector_Sl_std_complex_Sl_double_Sg__Sg____nonzero__((std::vector< std::complex< double > > const *)arg1);
@@ -17741,7 +17741,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___bool__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___bool__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -17754,7 +17754,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___bool__(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___bool__" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___bool__" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = (bool)std_vector_Sl_std_complex_Sl_double_Sg__Sg____bool__((std::vector< std::complex< double > > const *)arg1);
@@ -17765,7 +17765,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___len__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___len__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -17778,7 +17778,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___len__(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___len__" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___len__" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = std_vector_Sl_std_complex_Sl_double_Sg__Sg____len__((std::vector< std::complex< double > > const *)arg1);
@@ -17789,7 +17789,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___getslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___getslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::difference_type arg2 ;
@@ -17804,20 +17804,20 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___getslice__(PyObject *self, PyObjec
   std::vector< std::complex< double >,std::allocator< std::complex< double > > > *result = 0 ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_complex_t___getslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_complex_T___getslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___getslice__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___getslice__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t___getslice__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T___getslice__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::complex< double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_t___getslice__" "', argument " "3"" of type '" "std::vector< std::complex< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_T___getslice__" "', argument " "3"" of type '" "std::vector< std::complex< double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::complex< double > >::difference_type >(val3);
   try {
@@ -17834,7 +17834,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::difference_type arg2 ;
@@ -17850,17 +17850,17 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setslice____SWIG_0(PyObject *self,
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___setslice__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___setslice__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t___setslice__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T___setslice__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::complex< double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_t___setslice__" "', argument " "3"" of type '" "std::vector< std::complex< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_T___setslice__" "', argument " "3"" of type '" "std::vector< std::complex< double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::complex< double > >::difference_type >(val3);
   try {
@@ -17877,7 +17877,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::difference_type arg2 ;
@@ -17895,27 +17895,27 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setslice____SWIG_1(PyObject *self,
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___setslice__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___setslice__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t___setslice__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T___setslice__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::complex< double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_t___setslice__" "', argument " "3"" of type '" "std::vector< std::complex< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_T___setslice__" "', argument " "3"" of type '" "std::vector< std::complex< double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::complex< double > >::difference_type >(val3);
   {
     std::vector< std::complex< double >,std::allocator< std::complex< double > > > *ptr = (std::vector< std::complex< double >,std::allocator< std::complex< double > > > *)0;
     res4 = swig::asptr(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_complex_t___setslice__" "', argument " "4"" of type '" "std::vector< std::complex< double >,std::allocator< std::complex< double > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_complex_T___setslice__" "', argument " "4"" of type '" "std::vector< std::complex< double >,std::allocator< std::complex< double > > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_complex_t___setslice__" "', argument " "4"" of type '" "std::vector< std::complex< double >,std::allocator< std::complex< double > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_complex_T___setslice__" "', argument " "4"" of type '" "std::vector< std::complex< double >,std::allocator< std::complex< double > > > const &""'"); 
     }
     arg4 = ptr;
   }
@@ -17935,13 +17935,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___setslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___setslice__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_t___setslice__", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_T___setslice__", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -17958,7 +17958,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setslice__(PyObject *self, PyObjec
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_complex_t___setslice____SWIG_0(self, argc, argv);
+          return _wrap_vector_complex_T___setslice____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -17981,7 +17981,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setslice__(PyObject *self, PyObjec
           int res = swig::asptr(argv[3], (std::vector< std::complex< double >,std::allocator< std::complex< double > > >**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vector_complex_t___setslice____SWIG_1(self, argc, argv);
+            return _wrap_vector_complex_T___setslice____SWIG_1(self, argc, argv);
           }
         }
       }
@@ -17989,7 +17989,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setslice__(PyObject *self, PyObjec
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_t___setslice__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_T___setslice__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::complex< double > >::__setslice__(std::vector< std::complex< double > >::difference_type,std::vector< std::complex< double > >::difference_type)\n"
     "    std::vector< std::complex< double > >::__setslice__(std::vector< std::complex< double > >::difference_type,std::vector< std::complex< double > >::difference_type,std::vector< std::complex< double >,std::allocator< std::complex< double > > > const &)\n");
@@ -17997,7 +17997,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___delslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___delslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::difference_type arg2 ;
@@ -18011,20 +18011,20 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___delslice__(PyObject *self, PyObjec
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_complex_t___delslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_complex_T___delslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___delslice__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___delslice__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t___delslice__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T___delslice__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::complex< double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_t___delslice__" "', argument " "3"" of type '" "std::vector< std::complex< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_T___delslice__" "', argument " "3"" of type '" "std::vector< std::complex< double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::complex< double > >::difference_type >(val3);
   try {
@@ -18041,7 +18041,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::difference_type arg2 ;
@@ -18054,12 +18054,12 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___delitem____SWIG_0(PyObject *self,
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___delitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___delitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t___delitem__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T___delitem__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::complex< double > >::difference_type >(val2);
   try {
@@ -18076,7 +18076,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -18088,12 +18088,12 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___getitem____SWIG_0(PyObject *self,
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___getitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___getitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -18111,7 +18111,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -18124,12 +18124,12 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setitem____SWIG_0(PyObject *self,
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___setitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___setitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -18137,10 +18137,10 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setitem____SWIG_0(PyObject *self,
     std::vector< std::complex< double >,std::allocator< std::complex< double > > > *ptr = (std::vector< std::complex< double >,std::allocator< std::complex< double > > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_complex_t___setitem__" "', argument " "3"" of type '" "std::vector< std::complex< double >,std::allocator< std::complex< double > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_complex_T___setitem__" "', argument " "3"" of type '" "std::vector< std::complex< double >,std::allocator< std::complex< double > > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_complex_t___setitem__" "', argument " "3"" of type '" "std::vector< std::complex< double >,std::allocator< std::complex< double > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_complex_T___setitem__" "', argument " "3"" of type '" "std::vector< std::complex< double >,std::allocator< std::complex< double > > > const &""'"); 
     }
     arg3 = ptr;
   }
@@ -18160,7 +18160,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -18171,12 +18171,12 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setitem____SWIG_1(PyObject *self,
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___setitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___setitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -18194,7 +18194,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -18205,12 +18205,12 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___delitem____SWIG_1(PyObject *self,
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___delitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___delitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -18228,13 +18228,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___delitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___delitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_t___delitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_T___delitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -18245,7 +18245,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___delitem__(PyObject *self, PyObject
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_complex_t___delitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_complex_T___delitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -18259,13 +18259,13 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___delitem__(PyObject *self, PyObject
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_complex_t___delitem____SWIG_0(self, argc, argv);
+        return _wrap_vector_complex_T___delitem____SWIG_0(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_t___delitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_T___delitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::complex< double > >::__delitem__(std::vector< std::complex< double > >::difference_type)\n"
     "    std::vector< std::complex< double > >::__delitem__(SWIGPY_SLICEOBJECT *)\n");
@@ -18273,7 +18273,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::difference_type arg2 ;
@@ -18287,12 +18287,12 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___getitem____SWIG_1(PyObject *self,
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___getitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___getitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t___getitem__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T___getitem__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::complex< double > >::difference_type >(val2);
   try {
@@ -18308,13 +18308,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___getitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___getitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_t___getitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_T___getitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -18325,7 +18325,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___getitem__(PyObject *self, PyObject
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_complex_t___getitem____SWIG_0(self, argc, argv);
+        return _wrap_vector_complex_T___getitem____SWIG_0(self, argc, argv);
       }
     }
   }
@@ -18339,13 +18339,13 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___getitem__(PyObject *self, PyObject
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_complex_t___getitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_complex_T___getitem____SWIG_1(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_t___getitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_T___getitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::complex< double > >::__getitem__(SWIGPY_SLICEOBJECT *)\n"
     "    std::vector< std::complex< double > >::__getitem__(std::vector< std::complex< double > >::difference_type) const\n");
@@ -18353,7 +18353,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::difference_type arg2 ;
@@ -18370,17 +18370,17 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setitem____SWIG_2(PyObject *self,
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___setitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___setitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t___setitem__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T___setitem__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::complex< double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_std_complex_Sl_double_Sg_(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_t___setitem__" "', argument " "3"" of type '" "std::vector< std::complex< double > >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_T___setitem__" "', argument " "3"" of type '" "std::vector< std::complex< double > >::value_type""'");
   } 
   temp3 = static_cast< std::vector< std::complex< double > >::value_type >(val3);
   arg3 = &temp3;
@@ -18396,13 +18396,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___setitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___setitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_t___setitem__", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_T___setitem__", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -18413,7 +18413,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setitem__(PyObject *self, PyObject
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_complex_t___setitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_complex_T___setitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -18429,7 +18429,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setitem__(PyObject *self, PyObject
         int res = swig::asptr(argv[2], (std::vector< std::complex< double >,std::allocator< std::complex< double > > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vector_complex_t___setitem____SWIG_0(self, argc, argv);
+          return _wrap_vector_complex_T___setitem____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -18449,14 +18449,14 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setitem__(PyObject *self, PyObject
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_complex_t___setitem____SWIG_2(self, argc, argv);
+          return _wrap_vector_complex_T___setitem____SWIG_2(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_t___setitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_T___setitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::complex< double > >::__setitem__(SWIGPY_SLICEOBJECT *,std::vector< std::complex< double >,std::allocator< std::complex< double > > > const &)\n"
     "    std::vector< std::complex< double > >::__setitem__(SWIGPY_SLICEOBJECT *)\n"
@@ -18465,7 +18465,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_pop(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_pop(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -18478,7 +18478,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_pop(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_pop" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_pop" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   try {
@@ -18493,7 +18493,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_append(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_append(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::value_type *arg2 = 0 ;
@@ -18505,15 +18505,15 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_append(PyObject *self, PyObject *arg
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_complex_t_append", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_complex_T_append", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_append" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_append" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_std_complex_Sl_double_Sg_(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t_append" "', argument " "2"" of type '" "std::vector< std::complex< double > >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T_append" "', argument " "2"" of type '" "std::vector< std::complex< double > >::value_type""'");
   } 
   temp2 = static_cast< std::vector< std::complex< double > >::value_type >(val2);
   arg2 = &temp2;
@@ -18525,7 +18525,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_complex_t__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
+SWIGINTERN PyObject *_wrap_new_vector_complex_T__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *result = 0 ;
   
@@ -18539,7 +18539,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_complex_t__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_complex_T__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = 0 ;
   int res1 = SWIG_OLDOBJ ;
@@ -18551,10 +18551,10 @@ SWIGINTERN PyObject *_wrap_new_vector_complex_t__SWIG_1(PyObject *self, Py_ssize
     std::vector< std::complex< double >,std::allocator< std::complex< double > > > *ptr = (std::vector< std::complex< double >,std::allocator< std::complex< double > > > *)0;
     res1 = swig::asptr(swig_obj[0], &ptr);
     if (!SWIG_IsOK(res1)) {
-      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vector_complex_t" "', argument " "1"" of type '" "std::vector< std::complex< double > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vector_complex_T" "', argument " "1"" of type '" "std::vector< std::complex< double > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_complex_t" "', argument " "1"" of type '" "std::vector< std::complex< double > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_complex_T" "', argument " "1"" of type '" "std::vector< std::complex< double > > const &""'"); 
     }
     arg1 = ptr;
   }
@@ -18568,7 +18568,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_empty(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_empty(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -18581,7 +18581,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_empty(PyObject *self, PyObject *args
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_empty" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_empty" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = (bool)((std::vector< std::complex< double > > const *)arg1)->empty();
@@ -18592,7 +18592,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_size(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_size(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -18605,7 +18605,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_size(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_size" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_size" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = ((std::vector< std::complex< double > > const *)arg1)->size();
@@ -18616,7 +18616,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_swap(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_swap(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > > *arg2 = 0 ;
@@ -18627,18 +18627,18 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_swap(PyObject *self, PyObject *args)
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_complex_t_swap", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_complex_T_swap", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_swap" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_swap" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], &argp2, SWIGTYPE_p_std__vectorT_std__complexT_double_t_t,  0 );
   if (!SWIG_IsOK(res2)) {
-    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_complex_t_swap" "', argument " "2"" of type '" "std::vector< std::complex< double > > &""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_complex_T_swap" "', argument " "2"" of type '" "std::vector< std::complex< double > > &""'"); 
   }
   if (!argp2) {
-    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_complex_t_swap" "', argument " "2"" of type '" "std::vector< std::complex< double > > &""'"); 
+    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_complex_T_swap" "', argument " "2"" of type '" "std::vector< std::complex< double > > &""'"); 
   }
   arg2 = reinterpret_cast< std::vector< std::complex< double > > * >(argp2);
   (arg1)->swap(*arg2);
@@ -18649,7 +18649,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_begin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_begin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -18662,7 +18662,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_begin(PyObject *self, PyObject *args
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_begin" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_begin" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = (arg1)->begin();
@@ -18674,7 +18674,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_end(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_end(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -18687,7 +18687,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_end(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_end" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_end" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = (arg1)->end();
@@ -18699,7 +18699,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_rbegin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_rbegin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -18712,7 +18712,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_rbegin(PyObject *self, PyObject *arg
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_rbegin" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_rbegin" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = (arg1)->rbegin();
@@ -18724,7 +18724,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_rend(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_rend(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -18737,7 +18737,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_rend(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_rend" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_rend" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = (arg1)->rend();
@@ -18749,7 +18749,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_clear(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_clear(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -18761,7 +18761,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_clear(PyObject *self, PyObject *args
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_clear" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_clear" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   (arg1)->clear();
@@ -18772,7 +18772,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_get_allocator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_get_allocator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -18785,7 +18785,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_get_allocator(PyObject *self, PyObje
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_get_allocator" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_get_allocator" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = ((std::vector< std::complex< double > > const *)arg1)->get_allocator();
@@ -18796,7 +18796,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_complex_t__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_complex_T__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > >::size_type arg1 ;
   size_t val1 ;
@@ -18807,7 +18807,7 @@ SWIGINTERN PyObject *_wrap_new_vector_complex_t__SWIG_2(PyObject *self, Py_ssize
   if ((nobjs < 1) || (nobjs > 1)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_complex_t" "', argument " "1"" of type '" "std::vector< std::complex< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_complex_T" "', argument " "1"" of type '" "std::vector< std::complex< double > >::size_type""'");
   } 
   arg1 = static_cast< std::vector< std::complex< double > >::size_type >(val1);
   result = (std::vector< std::complex< double > > *)new std::vector< std::complex< double > >(arg1);
@@ -18818,7 +18818,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_pop_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_pop_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -18830,7 +18830,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_pop_back(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_pop_back" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_pop_back" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   (arg1)->pop_back();
@@ -18841,7 +18841,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::size_type arg2 ;
@@ -18854,12 +18854,12 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_resize__SWIG_0(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_resize" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_resize" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t_resize" "', argument " "2"" of type '" "std::vector< std::complex< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T_resize" "', argument " "2"" of type '" "std::vector< std::complex< double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::complex< double > >::size_type >(val2);
   (arg1)->resize(arg2);
@@ -18870,7 +18870,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::iterator arg2 ;
@@ -18884,18 +18884,18 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_erase__SWIG_0(PyObject *self, Py_ssi
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_erase" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_erase" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t_erase" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T_erase" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t_erase" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T_erase" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
     }
   }
   result = std_vector_Sl_std_complex_Sl_double_Sg__Sg__erase__SWIG_0(arg1,SWIG_STD_MOVE(arg2));
@@ -18907,7 +18907,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::iterator arg2 ;
@@ -18924,29 +18924,29 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_erase__SWIG_1(PyObject *self, Py_ssi
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_erase" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_erase" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t_erase" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T_erase" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t_erase" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T_erase" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
     }
   }
   res3 = SWIG_ConvertPtr(swig_obj[2], SWIG_as_voidptrptr(&iter3), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res3) || !iter3) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t_erase" "', argument " "3"" of type '" "std::vector< std::complex< double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T_erase" "', argument " "3"" of type '" "std::vector< std::complex< double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *>(iter3);
     if (iter_t) {
       arg3 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t_erase" "', argument " "3"" of type '" "std::vector< std::complex< double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T_erase" "', argument " "3"" of type '" "std::vector< std::complex< double > >::iterator""'");
     }
   }
   result = std_vector_Sl_std_complex_Sl_double_Sg__Sg__erase__SWIG_1(arg1,SWIG_STD_MOVE(arg2),SWIG_STD_MOVE(arg3));
@@ -18958,13 +18958,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_erase(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_erase(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_t_erase", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_T_erase", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -18975,7 +18975,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_erase(PyObject *self, PyObject *args
       int res = SWIG_ConvertPtr(argv[1], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
       _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *>(iter) != 0));
       if (_v) {
-        return _wrap_vector_complex_t_erase__SWIG_0(self, argc, argv);
+        return _wrap_vector_complex_T_erase__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -18992,14 +18992,14 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_erase(PyObject *self, PyObject *args
         int res = SWIG_ConvertPtr(argv[2], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
         _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *>(iter) != 0));
         if (_v) {
-          return _wrap_vector_complex_t_erase__SWIG_1(self, argc, argv);
+          return _wrap_vector_complex_T_erase__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_t_erase'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_T_erase'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::complex< double > >::erase(std::vector< std::complex< double > >::iterator)\n"
     "    std::vector< std::complex< double > >::erase(std::vector< std::complex< double > >::iterator,std::vector< std::complex< double > >::iterator)\n");
@@ -19007,7 +19007,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_complex_t__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_complex_T__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > >::size_type arg1 ;
   std::vector< std::complex< double > >::value_type *arg2 = 0 ;
@@ -19022,12 +19022,12 @@ SWIGINTERN PyObject *_wrap_new_vector_complex_t__SWIG_3(PyObject *self, Py_ssize
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_complex_t" "', argument " "1"" of type '" "std::vector< std::complex< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_complex_T" "', argument " "1"" of type '" "std::vector< std::complex< double > >::size_type""'");
   } 
   arg1 = static_cast< std::vector< std::complex< double > >::size_type >(val1);
   ecode2 = SWIG_AsVal_std_complex_Sl_double_Sg_(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "new_vector_complex_t" "', argument " "2"" of type '" "std::vector< std::complex< double > >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "new_vector_complex_T" "', argument " "2"" of type '" "std::vector< std::complex< double > >::value_type""'");
   } 
   temp2 = static_cast< std::vector< std::complex< double > >::value_type >(val2);
   arg2 = &temp2;
@@ -19039,16 +19039,16 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_complex_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_new_vector_complex_T(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vector_complex_t", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vector_complex_T", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 0) {
-    return _wrap_new_vector_complex_t__SWIG_0(self, argc, argv);
+    return _wrap_new_vector_complex_T__SWIG_0(self, argc, argv);
   }
   if (argc == 1) {
     int _v = 0;
@@ -19057,7 +19057,7 @@ SWIGINTERN PyObject *_wrap_new_vector_complex_t(PyObject *self, PyObject *args)
       _v = SWIG_CheckState(res);
     }
     if (_v) {
-      return _wrap_new_vector_complex_t__SWIG_2(self, argc, argv);
+      return _wrap_new_vector_complex_T__SWIG_2(self, argc, argv);
     }
   }
   if (argc == 1) {
@@ -19065,7 +19065,7 @@ SWIGINTERN PyObject *_wrap_new_vector_complex_t(PyObject *self, PyObject *args)
     int res = swig::asptr(argv[0], (std::vector< std::complex< double >,std::allocator< std::complex< double > > >**)(0));
     _v = SWIG_CheckState(res);
     if (_v) {
-      return _wrap_new_vector_complex_t__SWIG_1(self, argc, argv);
+      return _wrap_new_vector_complex_T__SWIG_1(self, argc, argv);
     }
   }
   if (argc == 2) {
@@ -19080,13 +19080,13 @@ SWIGINTERN PyObject *_wrap_new_vector_complex_t(PyObject *self, PyObject *args)
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_new_vector_complex_t__SWIG_3(self, argc, argv);
+        return _wrap_new_vector_complex_T__SWIG_3(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vector_complex_t'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vector_complex_T'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::complex< double > >::vector()\n"
     "    std::vector< std::complex< double > >::vector(std::vector< std::complex< double > > const &)\n"
@@ -19096,7 +19096,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_push_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_push_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::value_type *arg2 = 0 ;
@@ -19108,15 +19108,15 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_push_back(PyObject *self, PyObject *
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_complex_t_push_back", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_complex_T_push_back", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_push_back" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_push_back" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_std_complex_Sl_double_Sg_(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t_push_back" "', argument " "2"" of type '" "std::vector< std::complex< double > >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T_push_back" "', argument " "2"" of type '" "std::vector< std::complex< double > >::value_type""'");
   } 
   temp2 = static_cast< std::vector< std::complex< double > >::value_type >(val2);
   arg2 = &temp2;
@@ -19128,7 +19128,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_front(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_front(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -19141,7 +19141,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_front(PyObject *self, PyObject *args
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_front" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_front" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = (std::vector< std::complex< double > >::value_type *) &((std::vector< std::complex< double > > const *)arg1)->front();
@@ -19153,7 +19153,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -19166,7 +19166,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_back(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_back" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_back" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = (std::vector< std::complex< double > >::value_type *) &((std::vector< std::complex< double > > const *)arg1)->back();
@@ -19178,7 +19178,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_assign(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_assign(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::size_type arg2 ;
@@ -19193,20 +19193,20 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_assign(PyObject *self, PyObject *arg
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_complex_t_assign", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_complex_T_assign", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_assign" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_assign" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t_assign" "', argument " "2"" of type '" "std::vector< std::complex< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T_assign" "', argument " "2"" of type '" "std::vector< std::complex< double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::complex< double > >::size_type >(val2);
   ecode3 = SWIG_AsVal_std_complex_Sl_double_Sg_(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_t_assign" "', argument " "3"" of type '" "std::vector< std::complex< double > >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_T_assign" "', argument " "3"" of type '" "std::vector< std::complex< double > >::value_type""'");
   } 
   temp3 = static_cast< std::vector< std::complex< double > >::value_type >(val3);
   arg3 = &temp3;
@@ -19218,7 +19218,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::size_type arg2 ;
@@ -19235,17 +19235,17 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_resize__SWIG_1(PyObject *self, Py_ss
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_resize" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_resize" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t_resize" "', argument " "2"" of type '" "std::vector< std::complex< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T_resize" "', argument " "2"" of type '" "std::vector< std::complex< double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::complex< double > >::size_type >(val2);
   ecode3 = SWIG_AsVal_std_complex_Sl_double_Sg_(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_t_resize" "', argument " "3"" of type '" "std::vector< std::complex< double > >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_T_resize" "', argument " "3"" of type '" "std::vector< std::complex< double > >::value_type""'");
   } 
   temp3 = static_cast< std::vector< std::complex< double > >::value_type >(val3);
   arg3 = &temp3;
@@ -19257,13 +19257,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_resize(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_resize(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_t_resize", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_T_resize", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -19275,7 +19275,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_resize(PyObject *self, PyObject *arg
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_complex_t_resize__SWIG_0(self, argc, argv);
+        return _wrap_vector_complex_T_resize__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -19294,14 +19294,14 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_resize(PyObject *self, PyObject *arg
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_complex_t_resize__SWIG_1(self, argc, argv);
+          return _wrap_vector_complex_T_resize__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_t_resize'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_T_resize'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::complex< double > >::resize(std::vector< std::complex< double > >::size_type)\n"
     "    std::vector< std::complex< double > >::resize(std::vector< std::complex< double > >::size_type,std::vector< std::complex< double > >::value_type const &)\n");
@@ -19309,7 +19309,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::iterator arg2 ;
@@ -19327,23 +19327,23 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_insert__SWIG_0(PyObject *self, Py_ss
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_insert" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_insert" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t_insert" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T_insert" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t_insert" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T_insert" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_std_complex_Sl_double_Sg_(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_t_insert" "', argument " "3"" of type '" "std::vector< std::complex< double > >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_T_insert" "', argument " "3"" of type '" "std::vector< std::complex< double > >::value_type""'");
   } 
   temp3 = static_cast< std::vector< std::complex< double > >::value_type >(val3);
   arg3 = &temp3;
@@ -19356,7 +19356,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::iterator arg2 ;
@@ -19376,28 +19376,28 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_insert__SWIG_1(PyObject *self, Py_ss
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_insert" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_insert" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t_insert" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T_insert" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t_insert" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T_insert" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_size_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_t_insert" "', argument " "3"" of type '" "std::vector< std::complex< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_T_insert" "', argument " "3"" of type '" "std::vector< std::complex< double > >::size_type""'");
   } 
   arg3 = static_cast< std::vector< std::complex< double > >::size_type >(val3);
   ecode4 = SWIG_AsVal_std_complex_Sl_double_Sg_(swig_obj[3], &val4);
   if (!SWIG_IsOK(ecode4)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode4), "in method '" "vector_complex_t_insert" "', argument " "4"" of type '" "std::vector< std::complex< double > >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode4), "in method '" "vector_complex_T_insert" "', argument " "4"" of type '" "std::vector< std::complex< double > >::value_type""'");
   } 
   temp4 = static_cast< std::vector< std::complex< double > >::value_type >(val4);
   arg4 = &temp4;
@@ -19409,13 +19409,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_insert(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_insert(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_t_insert", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_T_insert", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -19431,7 +19431,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_insert(PyObject *self, PyObject *arg
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_complex_t_insert__SWIG_0(self, argc, argv);
+          return _wrap_vector_complex_T_insert__SWIG_0(self, argc, argv);
         }
       }
     }
@@ -19455,7 +19455,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_insert(PyObject *self, PyObject *arg
             _v = SWIG_CheckState(res);
           }
           if (_v) {
-            return _wrap_vector_complex_t_insert__SWIG_1(self, argc, argv);
+            return _wrap_vector_complex_T_insert__SWIG_1(self, argc, argv);
           }
         }
       }
@@ -19463,7 +19463,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_insert(PyObject *self, PyObject *arg
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_t_insert'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_T_insert'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::complex< double > >::insert(std::vector< std::complex< double > >::iterator,std::vector< std::complex< double > >::value_type const &)\n"
     "    std::vector< std::complex< double > >::insert(std::vector< std::complex< double > >::iterator,std::vector< std::complex< double > >::size_type,std::vector< std::complex< double > >::value_type const &)\n");
@@ -19471,7 +19471,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_reserve(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_reserve(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::size_type arg2 ;
@@ -19482,15 +19482,15 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_reserve(PyObject *self, PyObject *ar
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_complex_t_reserve", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_complex_T_reserve", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_reserve" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_reserve" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t_reserve" "', argument " "2"" of type '" "std::vector< std::complex< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T_reserve" "', argument " "2"" of type '" "std::vector< std::complex< double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::complex< double > >::size_type >(val2);
   (arg1)->reserve(arg2);
@@ -19501,7 +19501,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_capacity(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_capacity(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -19514,7 +19514,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_capacity(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_capacity" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_capacity" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = ((std::vector< std::complex< double > > const *)arg1)->capacity();
@@ -19525,7 +19525,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_delete_vector_complex_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_delete_vector_complex_T(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -19537,7 +19537,7 @@ SWIGINTERN PyObject *_wrap_delete_vector_complex_t(PyObject *self, PyObject *arg
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, SWIG_POINTER_DISOWN |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vector_complex_t" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vector_complex_T" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   {
@@ -19558,18 +19558,18 @@ fail:
 }
 
 
-SWIGINTERN PyObject *vector_complex_t_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vector_complex_T_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   PyObject *obj;
   if (!SWIG_Python_UnpackTuple(args, "swigregister", 1, 1, &obj)) return NULL;
   SWIG_TypeNewClientData(SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, SWIG_NewClientData(obj));
   return SWIG_Py_Void();
 }
 
-SWIGINTERN PyObject *vector_complex_t_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vector_complex_T_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   return SWIG_Python_InitShadowInstance(args);
 }
 
-SWIGINTERN PyObject *_wrap_vector_string_t_iterator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_iterator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   PyObject **arg2 = (PyObject **) 0 ;
@@ -19584,7 +19584,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_iterator(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_iterator" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_iterator" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = (swig::SwigPyIterator *)std_vector_Sl_std_string_Sg__iterator(arg1,arg2);
@@ -19595,7 +19595,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___nonzero__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T___nonzero__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -19608,7 +19608,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t___nonzero__(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___nonzero__" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___nonzero__" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = (bool)std_vector_Sl_std_string_Sg____nonzero__((std::vector< std::string > const *)arg1);
@@ -19619,7 +19619,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___bool__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T___bool__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -19632,7 +19632,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t___bool__(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___bool__" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___bool__" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = (bool)std_vector_Sl_std_string_Sg____bool__((std::vector< std::string > const *)arg1);
@@ -19643,7 +19643,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___len__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T___len__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -19656,7 +19656,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t___len__(PyObject *self, PyObject *arg
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___len__" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___len__" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = std_vector_Sl_std_string_Sg____len__((std::vector< std::string > const *)arg1);
@@ -19667,7 +19667,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___getslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T___getslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::difference_type arg2 ;
@@ -19682,20 +19682,20 @@ SWIGINTERN PyObject *_wrap_vector_string_t___getslice__(PyObject *self, PyObject
   std::vector< std::string,std::allocator< std::string > > *result = 0 ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_string_t___getslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_string_T___getslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___getslice__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___getslice__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_t___getslice__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_T___getslice__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::string >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_string_t___getslice__" "', argument " "3"" of type '" "std::vector< std::string >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_string_T___getslice__" "', argument " "3"" of type '" "std::vector< std::string >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::string >::difference_type >(val3);
   try {
@@ -19712,7 +19712,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::difference_type arg2 ;
@@ -19728,17 +19728,17 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setslice____SWIG_0(PyObject *self,
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___setslice__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___setslice__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_t___setslice__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_T___setslice__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::string >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_string_t___setslice__" "', argument " "3"" of type '" "std::vector< std::string >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_string_T___setslice__" "', argument " "3"" of type '" "std::vector< std::string >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::string >::difference_type >(val3);
   try {
@@ -19755,7 +19755,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::difference_type arg2 ;
@@ -19773,27 +19773,27 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setslice____SWIG_1(PyObject *self,
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___setslice__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___setslice__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_t___setslice__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_T___setslice__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::string >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_string_t___setslice__" "', argument " "3"" of type '" "std::vector< std::string >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_string_T___setslice__" "', argument " "3"" of type '" "std::vector< std::string >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::string >::difference_type >(val3);
   {
     std::vector< std::string,std::allocator< std::string > > *ptr = (std::vector< std::string,std::allocator< std::string > > *)0;
     res4 = swig::asptr(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_string_t___setslice__" "', argument " "4"" of type '" "std::vector< std::string,std::allocator< std::string > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_string_T___setslice__" "', argument " "4"" of type '" "std::vector< std::string,std::allocator< std::string > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_t___setslice__" "', argument " "4"" of type '" "std::vector< std::string,std::allocator< std::string > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_T___setslice__" "', argument " "4"" of type '" "std::vector< std::string,std::allocator< std::string > > const &""'"); 
     }
     arg4 = ptr;
   }
@@ -19813,13 +19813,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___setslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T___setslice__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_t___setslice__", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_T___setslice__", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -19836,7 +19836,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setslice__(PyObject *self, PyObject
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_string_t___setslice____SWIG_0(self, argc, argv);
+          return _wrap_vector_string_T___setslice____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -19859,7 +19859,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setslice__(PyObject *self, PyObject
           int res = swig::asptr(argv[3], (std::vector< std::string,std::allocator< std::string > >**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vector_string_t___setslice____SWIG_1(self, argc, argv);
+            return _wrap_vector_string_T___setslice____SWIG_1(self, argc, argv);
           }
         }
       }
@@ -19867,7 +19867,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setslice__(PyObject *self, PyObject
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_t___setslice__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_T___setslice__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::string >::__setslice__(std::vector< std::string >::difference_type,std::vector< std::string >::difference_type)\n"
     "    std::vector< std::string >::__setslice__(std::vector< std::string >::difference_type,std::vector< std::string >::difference_type,std::vector< std::string,std::allocator< std::string > > const &)\n");
@@ -19875,7 +19875,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___delslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T___delslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::difference_type arg2 ;
@@ -19889,20 +19889,20 @@ SWIGINTERN PyObject *_wrap_vector_string_t___delslice__(PyObject *self, PyObject
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_string_t___delslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_string_T___delslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___delslice__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___delslice__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_t___delslice__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_T___delslice__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::string >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_string_t___delslice__" "', argument " "3"" of type '" "std::vector< std::string >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_string_T___delslice__" "', argument " "3"" of type '" "std::vector< std::string >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::string >::difference_type >(val3);
   try {
@@ -19919,7 +19919,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::difference_type arg2 ;
@@ -19932,12 +19932,12 @@ SWIGINTERN PyObject *_wrap_vector_string_t___delitem____SWIG_0(PyObject *self, P
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___delitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___delitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_t___delitem__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_T___delitem__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::string >::difference_type >(val2);
   try {
@@ -19954,7 +19954,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -19966,12 +19966,12 @@ SWIGINTERN PyObject *_wrap_vector_string_t___getitem____SWIG_0(PyObject *self, P
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___getitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___getitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -19989,7 +19989,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -20002,12 +20002,12 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setitem____SWIG_0(PyObject *self, P
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___setitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___setitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -20015,10 +20015,10 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setitem____SWIG_0(PyObject *self, P
     std::vector< std::string,std::allocator< std::string > > *ptr = (std::vector< std::string,std::allocator< std::string > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_string_t___setitem__" "', argument " "3"" of type '" "std::vector< std::string,std::allocator< std::string > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_string_T___setitem__" "', argument " "3"" of type '" "std::vector< std::string,std::allocator< std::string > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_t___setitem__" "', argument " "3"" of type '" "std::vector< std::string,std::allocator< std::string > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_T___setitem__" "', argument " "3"" of type '" "std::vector< std::string,std::allocator< std::string > > const &""'"); 
     }
     arg3 = ptr;
   }
@@ -20038,7 +20038,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -20049,12 +20049,12 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setitem____SWIG_1(PyObject *self, P
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___setitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___setitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -20072,7 +20072,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -20083,12 +20083,12 @@ SWIGINTERN PyObject *_wrap_vector_string_t___delitem____SWIG_1(PyObject *self, P
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___delitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___delitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -20106,13 +20106,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___delitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T___delitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_t___delitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_T___delitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -20123,7 +20123,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t___delitem__(PyObject *self, PyObject
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_string_t___delitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_string_T___delitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -20137,13 +20137,13 @@ SWIGINTERN PyObject *_wrap_vector_string_t___delitem__(PyObject *self, PyObject
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_string_t___delitem____SWIG_0(self, argc, argv);
+        return _wrap_vector_string_T___delitem____SWIG_0(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_t___delitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_T___delitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::string >::__delitem__(std::vector< std::string >::difference_type)\n"
     "    std::vector< std::string >::__delitem__(SWIGPY_SLICEOBJECT *)\n");
@@ -20151,7 +20151,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::difference_type arg2 ;
@@ -20165,12 +20165,12 @@ SWIGINTERN PyObject *_wrap_vector_string_t___getitem____SWIG_1(PyObject *self, P
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___getitem__" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___getitem__" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_t___getitem__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_T___getitem__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::string >::difference_type >(val2);
   try {
@@ -20186,13 +20186,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___getitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T___getitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_t___getitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_T___getitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -20203,7 +20203,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t___getitem__(PyObject *self, PyObject
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_string_t___getitem____SWIG_0(self, argc, argv);
+        return _wrap_vector_string_T___getitem____SWIG_0(self, argc, argv);
       }
     }
   }
@@ -20217,13 +20217,13 @@ SWIGINTERN PyObject *_wrap_vector_string_t___getitem__(PyObject *self, PyObject
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_string_t___getitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_string_T___getitem____SWIG_1(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_t___getitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_T___getitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::string >::__getitem__(SWIGPY_SLICEOBJECT *)\n"
     "    std::vector< std::string >::__getitem__(std::vector< std::string >::difference_type) const\n");
@@ -20231,7 +20231,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::difference_type arg2 ;
@@ -20246,22 +20246,22 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setitem____SWIG_2(PyObject *self, P
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___setitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___setitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_t___setitem__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_T___setitem__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::string >::difference_type >(val2);
   {
     std::string *ptr = (std::string *)0;
     res3 = SWIG_AsPtr_std_string(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_string_t___setitem__" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_string_T___setitem__" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_t___setitem__" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_T___setitem__" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -20279,13 +20279,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___setitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T___setitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_t___setitem__", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_T___setitem__", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -20296,7 +20296,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setitem__(PyObject *self, PyObject
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_string_t___setitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_string_T___setitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -20312,7 +20312,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setitem__(PyObject *self, PyObject
         int res = swig::asptr(argv[2], (std::vector< std::string,std::allocator< std::string > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vector_string_t___setitem____SWIG_0(self, argc, argv);
+          return _wrap_vector_string_T___setitem____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -20330,14 +20330,14 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setitem__(PyObject *self, PyObject
         int res = SWIG_AsPtr_std_string(argv[2], (std::string**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vector_string_t___setitem____SWIG_2(self, argc, argv);
+          return _wrap_vector_string_T___setitem____SWIG_2(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_t___setitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_T___setitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::string >::__setitem__(SWIGPY_SLICEOBJECT *,std::vector< std::string,std::allocator< std::string > > const &)\n"
     "    std::vector< std::string >::__setitem__(SWIGPY_SLICEOBJECT *)\n"
@@ -20346,7 +20346,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_pop(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_pop(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -20359,7 +20359,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_pop(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_pop" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_pop" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   try {
@@ -20374,7 +20374,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_append(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_append(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::value_type *arg2 = 0 ;
@@ -20384,20 +20384,20 @@ SWIGINTERN PyObject *_wrap_vector_string_t_append(PyObject *self, PyObject *args
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_string_t_append", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_string_T_append", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_append" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_append" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_string_t_append" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_string_T_append" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_t_append" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_T_append" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -20411,7 +20411,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_string_t__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
+SWIGINTERN PyObject *_wrap_new_vector_string_T__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
   PyObject *resultobj = 0;
   std::vector< std::string > *result = 0 ;
   
@@ -20425,7 +20425,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_string_t__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_string_T__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = 0 ;
   int res1 = SWIG_OLDOBJ ;
@@ -20437,10 +20437,10 @@ SWIGINTERN PyObject *_wrap_new_vector_string_t__SWIG_1(PyObject *self, Py_ssize_
     std::vector< std::string,std::allocator< std::string > > *ptr = (std::vector< std::string,std::allocator< std::string > > *)0;
     res1 = swig::asptr(swig_obj[0], &ptr);
     if (!SWIG_IsOK(res1)) {
-      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vector_string_t" "', argument " "1"" of type '" "std::vector< std::string > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vector_string_T" "', argument " "1"" of type '" "std::vector< std::string > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_string_t" "', argument " "1"" of type '" "std::vector< std::string > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_string_T" "', argument " "1"" of type '" "std::vector< std::string > const &""'"); 
     }
     arg1 = ptr;
   }
@@ -20454,7 +20454,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_empty(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_empty(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -20467,7 +20467,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_empty(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_empty" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_empty" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = (bool)((std::vector< std::string > const *)arg1)->empty();
@@ -20478,7 +20478,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_size(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_size(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -20491,7 +20491,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_size(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_size" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_size" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = ((std::vector< std::string > const *)arg1)->size();
@@ -20502,7 +20502,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_swap(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_swap(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string > *arg2 = 0 ;
@@ -20513,18 +20513,18 @@ SWIGINTERN PyObject *_wrap_vector_string_t_swap(PyObject *self, PyObject *args)
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_string_t_swap", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_string_T_swap", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_swap" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_swap" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], &argp2, SWIGTYPE_p_std__vectorT_std__string_t,  0 );
   if (!SWIG_IsOK(res2)) {
-    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_string_t_swap" "', argument " "2"" of type '" "std::vector< std::string > &""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_string_T_swap" "', argument " "2"" of type '" "std::vector< std::string > &""'"); 
   }
   if (!argp2) {
-    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_t_swap" "', argument " "2"" of type '" "std::vector< std::string > &""'"); 
+    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_T_swap" "', argument " "2"" of type '" "std::vector< std::string > &""'"); 
   }
   arg2 = reinterpret_cast< std::vector< std::string > * >(argp2);
   (arg1)->swap(*arg2);
@@ -20535,7 +20535,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_begin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_begin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -20548,7 +20548,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_begin(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_begin" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_begin" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = (arg1)->begin();
@@ -20560,7 +20560,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_end(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_end(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -20573,7 +20573,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_end(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_end" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_end" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = (arg1)->end();
@@ -20585,7 +20585,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_rbegin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_rbegin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -20598,7 +20598,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_rbegin(PyObject *self, PyObject *args
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_rbegin" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_rbegin" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = (arg1)->rbegin();
@@ -20610,7 +20610,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_rend(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_rend(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -20623,7 +20623,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_rend(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_rend" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_rend" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = (arg1)->rend();
@@ -20635,7 +20635,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_clear(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_clear(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -20647,7 +20647,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_clear(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_clear" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_clear" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   (arg1)->clear();
@@ -20658,7 +20658,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_get_allocator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_get_allocator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -20671,7 +20671,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_get_allocator(PyObject *self, PyObjec
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_get_allocator" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_get_allocator" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = ((std::vector< std::string > const *)arg1)->get_allocator();
@@ -20682,7 +20682,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_string_t__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_string_T__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string >::size_type arg1 ;
   size_t val1 ;
@@ -20693,7 +20693,7 @@ SWIGINTERN PyObject *_wrap_new_vector_string_t__SWIG_2(PyObject *self, Py_ssize_
   if ((nobjs < 1) || (nobjs > 1)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_string_t" "', argument " "1"" of type '" "std::vector< std::string >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_string_T" "', argument " "1"" of type '" "std::vector< std::string >::size_type""'");
   } 
   arg1 = static_cast< std::vector< std::string >::size_type >(val1);
   result = (std::vector< std::string > *)new std::vector< std::string >(arg1);
@@ -20704,7 +20704,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_pop_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_pop_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -20716,7 +20716,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_pop_back(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_pop_back" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_pop_back" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   (arg1)->pop_back();
@@ -20727,7 +20727,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::size_type arg2 ;
@@ -20740,12 +20740,12 @@ SWIGINTERN PyObject *_wrap_vector_string_t_resize__SWIG_0(PyObject *self, Py_ssi
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_resize" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_resize" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_t_resize" "', argument " "2"" of type '" "std::vector< std::string >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_T_resize" "', argument " "2"" of type '" "std::vector< std::string >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::string >::size_type >(val2);
   (arg1)->resize(arg2);
@@ -20756,7 +20756,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::iterator arg2 ;
@@ -20770,18 +20770,18 @@ SWIGINTERN PyObject *_wrap_vector_string_t_erase__SWIG_0(PyObject *self, Py_ssiz
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_erase" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_erase" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t_erase" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T_erase" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::string >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::string >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t_erase" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T_erase" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
     }
   }
   result = std_vector_Sl_std_string_Sg__erase__SWIG_0(arg1,SWIG_STD_MOVE(arg2));
@@ -20793,7 +20793,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::iterator arg2 ;
@@ -20810,29 +20810,29 @@ SWIGINTERN PyObject *_wrap_vector_string_t_erase__SWIG_1(PyObject *self, Py_ssiz
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_erase" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_erase" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t_erase" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T_erase" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::string >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::string >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t_erase" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T_erase" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
     }
   }
   res3 = SWIG_ConvertPtr(swig_obj[2], SWIG_as_voidptrptr(&iter3), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res3) || !iter3) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t_erase" "', argument " "3"" of type '" "std::vector< std::string >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T_erase" "', argument " "3"" of type '" "std::vector< std::string >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::string >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::string >::iterator > *>(iter3);
     if (iter_t) {
       arg3 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t_erase" "', argument " "3"" of type '" "std::vector< std::string >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T_erase" "', argument " "3"" of type '" "std::vector< std::string >::iterator""'");
     }
   }
   result = std_vector_Sl_std_string_Sg__erase__SWIG_1(arg1,SWIG_STD_MOVE(arg2),SWIG_STD_MOVE(arg3));
@@ -20844,13 +20844,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_erase(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_erase(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_t_erase", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_T_erase", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -20861,7 +20861,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_erase(PyObject *self, PyObject *args)
       int res = SWIG_ConvertPtr(argv[1], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
       _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< std::string >::iterator > *>(iter) != 0));
       if (_v) {
-        return _wrap_vector_string_t_erase__SWIG_0(self, argc, argv);
+        return _wrap_vector_string_T_erase__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -20878,14 +20878,14 @@ SWIGINTERN PyObject *_wrap_vector_string_t_erase(PyObject *self, PyObject *args)
         int res = SWIG_ConvertPtr(argv[2], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
         _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< std::string >::iterator > *>(iter) != 0));
         if (_v) {
-          return _wrap_vector_string_t_erase__SWIG_1(self, argc, argv);
+          return _wrap_vector_string_T_erase__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_t_erase'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_T_erase'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::string >::erase(std::vector< std::string >::iterator)\n"
     "    std::vector< std::string >::erase(std::vector< std::string >::iterator,std::vector< std::string >::iterator)\n");
@@ -20893,7 +20893,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_string_t__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_string_T__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string >::size_type arg1 ;
   std::vector< std::string >::value_type *arg2 = 0 ;
@@ -20906,17 +20906,17 @@ SWIGINTERN PyObject *_wrap_new_vector_string_t__SWIG_3(PyObject *self, Py_ssize_
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_string_t" "', argument " "1"" of type '" "std::vector< std::string >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_string_T" "', argument " "1"" of type '" "std::vector< std::string >::size_type""'");
   } 
   arg1 = static_cast< std::vector< std::string >::size_type >(val1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "new_vector_string_t" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "new_vector_string_T" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_string_t" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_string_T" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -20930,16 +20930,16 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_string_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_new_vector_string_T(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vector_string_t", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vector_string_T", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 0) {
-    return _wrap_new_vector_string_t__SWIG_0(self, argc, argv);
+    return _wrap_new_vector_string_T__SWIG_0(self, argc, argv);
   }
   if (argc == 1) {
     int _v = 0;
@@ -20948,7 +20948,7 @@ SWIGINTERN PyObject *_wrap_new_vector_string_t(PyObject *self, PyObject *args) {
       _v = SWIG_CheckState(res);
     }
     if (_v) {
-      return _wrap_new_vector_string_t__SWIG_2(self, argc, argv);
+      return _wrap_new_vector_string_T__SWIG_2(self, argc, argv);
     }
   }
   if (argc == 1) {
@@ -20956,7 +20956,7 @@ SWIGINTERN PyObject *_wrap_new_vector_string_t(PyObject *self, PyObject *args) {
     int res = swig::asptr(argv[0], (std::vector< std::string,std::allocator< std::string > >**)(0));
     _v = SWIG_CheckState(res);
     if (_v) {
-      return _wrap_new_vector_string_t__SWIG_1(self, argc, argv);
+      return _wrap_new_vector_string_T__SWIG_1(self, argc, argv);
     }
   }
   if (argc == 2) {
@@ -20969,13 +20969,13 @@ SWIGINTERN PyObject *_wrap_new_vector_string_t(PyObject *self, PyObject *args) {
       int res = SWIG_AsPtr_std_string(argv[1], (std::string**)(0));
       _v = SWIG_CheckState(res);
       if (_v) {
-        return _wrap_new_vector_string_t__SWIG_3(self, argc, argv);
+        return _wrap_new_vector_string_T__SWIG_3(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vector_string_t'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vector_string_T'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::string >::vector()\n"
     "    std::vector< std::string >::vector(std::vector< std::string > const &)\n"
@@ -20985,7 +20985,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_push_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_push_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::value_type *arg2 = 0 ;
@@ -20995,20 +20995,20 @@ SWIGINTERN PyObject *_wrap_vector_string_t_push_back(PyObject *self, PyObject *a
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_string_t_push_back", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_string_T_push_back", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_push_back" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_push_back" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_string_t_push_back" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_string_T_push_back" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_t_push_back" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_T_push_back" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -21022,7 +21022,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_front(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_front(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -21035,7 +21035,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_front(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_front" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_front" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = (std::vector< std::string >::value_type *) &((std::vector< std::string > const *)arg1)->front();
@@ -21047,7 +21047,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -21060,7 +21060,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_back(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_back" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_back" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = (std::vector< std::string >::value_type *) &((std::vector< std::string > const *)arg1)->back();
@@ -21072,7 +21072,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_assign(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_assign(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::size_type arg2 ;
@@ -21085,25 +21085,25 @@ SWIGINTERN PyObject *_wrap_vector_string_t_assign(PyObject *self, PyObject *args
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_string_t_assign", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_string_T_assign", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_assign" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_assign" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_t_assign" "', argument " "2"" of type '" "std::vector< std::string >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_T_assign" "', argument " "2"" of type '" "std::vector< std::string >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::string >::size_type >(val2);
   {
     std::string *ptr = (std::string *)0;
     res3 = SWIG_AsPtr_std_string(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_string_t_assign" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_string_T_assign" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_t_assign" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_T_assign" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -21117,7 +21117,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::size_type arg2 ;
@@ -21132,22 +21132,22 @@ SWIGINTERN PyObject *_wrap_vector_string_t_resize__SWIG_1(PyObject *self, Py_ssi
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_resize" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_resize" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_t_resize" "', argument " "2"" of type '" "std::vector< std::string >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_T_resize" "', argument " "2"" of type '" "std::vector< std::string >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::string >::size_type >(val2);
   {
     std::string *ptr = (std::string *)0;
     res3 = SWIG_AsPtr_std_string(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_string_t_resize" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_string_T_resize" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_t_resize" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_T_resize" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -21161,13 +21161,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_resize(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_resize(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_t_resize", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_T_resize", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -21179,7 +21179,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_resize(PyObject *self, PyObject *args
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_string_t_resize__SWIG_0(self, argc, argv);
+        return _wrap_vector_string_T_resize__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -21196,14 +21196,14 @@ SWIGINTERN PyObject *_wrap_vector_string_t_resize(PyObject *self, PyObject *args
         int res = SWIG_AsPtr_std_string(argv[2], (std::string**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vector_string_t_resize__SWIG_1(self, argc, argv);
+          return _wrap_vector_string_T_resize__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_t_resize'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_T_resize'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::string >::resize(std::vector< std::string >::size_type)\n"
     "    std::vector< std::string >::resize(std::vector< std::string >::size_type,std::vector< std::string >::value_type const &)\n");
@@ -21211,7 +21211,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::iterator arg2 ;
@@ -21227,28 +21227,28 @@ SWIGINTERN PyObject *_wrap_vector_string_t_insert__SWIG_0(PyObject *self, Py_ssi
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_insert" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_insert" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t_insert" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T_insert" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::string >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::string >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t_insert" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T_insert" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
     }
   }
   {
     std::string *ptr = (std::string *)0;
     res3 = SWIG_AsPtr_std_string(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_string_t_insert" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_string_T_insert" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_t_insert" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_T_insert" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -21263,7 +21263,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::iterator arg2 ;
@@ -21281,33 +21281,33 @@ SWIGINTERN PyObject *_wrap_vector_string_t_insert__SWIG_1(PyObject *self, Py_ssi
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_insert" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_insert" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t_insert" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T_insert" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::string >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::string >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t_insert" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T_insert" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_size_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_string_t_insert" "', argument " "3"" of type '" "std::vector< std::string >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_string_T_insert" "', argument " "3"" of type '" "std::vector< std::string >::size_type""'");
   } 
   arg3 = static_cast< std::vector< std::string >::size_type >(val3);
   {
     std::string *ptr = (std::string *)0;
     res4 = SWIG_AsPtr_std_string(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_string_t_insert" "', argument " "4"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_string_T_insert" "', argument " "4"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_t_insert" "', argument " "4"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_T_insert" "', argument " "4"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     arg4 = ptr;
   }
@@ -21321,13 +21321,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_insert(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_insert(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_t_insert", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_T_insert", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -21341,7 +21341,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_insert(PyObject *self, PyObject *args
         int res = SWIG_AsPtr_std_string(argv[2], (std::string**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vector_string_t_insert__SWIG_0(self, argc, argv);
+          return _wrap_vector_string_T_insert__SWIG_0(self, argc, argv);
         }
       }
     }
@@ -21363,7 +21363,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_insert(PyObject *self, PyObject *args
           int res = SWIG_AsPtr_std_string(argv[3], (std::string**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vector_string_t_insert__SWIG_1(self, argc, argv);
+            return _wrap_vector_string_T_insert__SWIG_1(self, argc, argv);
           }
         }
       }
@@ -21371,7 +21371,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_insert(PyObject *self, PyObject *args
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_t_insert'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_T_insert'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::string >::insert(std::vector< std::string >::iterator,std::vector< std::string >::value_type const &)\n"
     "    std::vector< std::string >::insert(std::vector< std::string >::iterator,std::vector< std::string >::size_type,std::vector< std::string >::value_type const &)\n");
@@ -21379,7 +21379,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_reserve(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_reserve(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::size_type arg2 ;
@@ -21390,15 +21390,15 @@ SWIGINTERN PyObject *_wrap_vector_string_t_reserve(PyObject *self, PyObject *arg
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_string_t_reserve", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_string_T_reserve", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_reserve" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_reserve" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_t_reserve" "', argument " "2"" of type '" "std::vector< std::string >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_T_reserve" "', argument " "2"" of type '" "std::vector< std::string >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::string >::size_type >(val2);
   (arg1)->reserve(arg2);
@@ -21409,7 +21409,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_capacity(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_capacity(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -21422,7 +21422,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_capacity(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_capacity" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_capacity" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = ((std::vector< std::string > const *)arg1)->capacity();
@@ -21433,7 +21433,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_delete_vector_string_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_delete_vector_string_T(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -21445,7 +21445,7 @@ SWIGINTERN PyObject *_wrap_delete_vector_string_t(PyObject *self, PyObject *args
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, SWIG_POINTER_DISOWN |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vector_string_t" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vector_string_T" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   {
@@ -21466,18 +21466,18 @@ fail:
 }
 
 
-SWIGINTERN PyObject *vector_string_t_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vector_string_T_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   PyObject *obj;
   if (!SWIG_Python_UnpackTuple(args, "swigregister", 1, 1, &obj)) return NULL;
   SWIG_TypeNewClientData(SWIGTYPE_p_std__vectorT_std__string_t, SWIG_NewClientData(obj));
   return SWIG_Py_Void();
 }
 
-SWIGINTERN PyObject *vector_string_t_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vector_string_T_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   return SWIG_Python_InitShadowInstance(args);
 }
 
-SWIGINTERN PyObject *_wrap_new_map_string_double_t__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_map_string_double_T__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::less< std::string > *arg1 = 0 ;
   void *argp1 = 0 ;
@@ -21488,10 +21488,10 @@ SWIGINTERN PyObject *_wrap_new_map_string_double_t__SWIG_0(PyObject *self, Py_ss
   if ((nobjs < 1) || (nobjs > 1)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1, SWIGTYPE_p_std__lessT_std__string_t,  0  | 0);
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_map_string_double_t" "', argument " "1"" of type '" "std::less< std::string > const &""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_map_string_double_T" "', argument " "1"" of type '" "std::less< std::string > const &""'"); 
   }
   if (!argp1) {
-    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_map_string_double_t" "', argument " "1"" of type '" "std::less< std::string > const &""'"); 
+    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_map_string_double_T" "', argument " "1"" of type '" "std::less< std::string > const &""'"); 
   }
   arg1 = reinterpret_cast< std::less< std::string > * >(argp1);
   result = (std::map< std::string,double > *)new std::map< std::string,double >((std::less< std::string > const &)*arg1);
@@ -21502,7 +21502,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_iterator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_iterator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   PyObject **arg2 = (PyObject **) 0 ;
@@ -21517,7 +21517,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_iterator(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_iterator" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_iterator" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (swig::SwigPyIterator *)std_map_Sl_std_string_Sc_double_Sg__iterator(arg1,arg2);
@@ -21528,7 +21528,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t___nonzero__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T___nonzero__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -21541,7 +21541,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t___nonzero__(PyObject *self, PyObj
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t___nonzero__" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T___nonzero__" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (bool)std_map_Sl_std_string_Sc_double_Sg____nonzero__((std::map< std::string,double > const *)arg1);
@@ -21552,7 +21552,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t___bool__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T___bool__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -21565,7 +21565,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t___bool__(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t___bool__" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T___bool__" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (bool)std_map_Sl_std_string_Sc_double_Sg____bool__((std::map< std::string,double > const *)arg1);
@@ -21576,7 +21576,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t___len__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T___len__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -21589,7 +21589,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t___len__(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t___len__" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T___len__" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = std_map_Sl_std_string_Sc_double_Sg____len__((std::map< std::string,double > const *)arg1);
@@ -21600,7 +21600,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t___getitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T___getitem__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::key_type *arg2 = 0 ;
@@ -21611,20 +21611,20 @@ SWIGINTERN PyObject *_wrap_map_string_double_t___getitem__(PyObject *self, PyObj
   std::map< std::string,double >::mapped_type *result = 0 ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "map_string_double_t___getitem__", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "map_string_double_T___getitem__", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t___getitem__" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T___getitem__" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t___getitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T___getitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t___getitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T___getitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -21642,7 +21642,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t___delitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T___delitem__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::key_type *arg2 = 0 ;
@@ -21652,20 +21652,20 @@ SWIGINTERN PyObject *_wrap_map_string_double_t___delitem__(PyObject *self, PyObj
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "map_string_double_t___delitem__", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "map_string_double_T___delitem__", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t___delitem__" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T___delitem__" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t___delitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T___delitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t___delitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T___delitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -21683,7 +21683,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_has_key(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_has_key(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::key_type *arg2 = 0 ;
@@ -21694,20 +21694,20 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_has_key(PyObject *self, PyObject
   bool result;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "map_string_double_t_has_key", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "map_string_double_T_has_key", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_has_key" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_has_key" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t_has_key" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T_has_key" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t_has_key" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T_has_key" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -21721,7 +21721,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_keys(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_keys(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -21734,7 +21734,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_keys(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_keys" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_keys" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (PyObject *)std_map_Sl_std_string_Sc_double_Sg__keys(arg1);
@@ -21745,7 +21745,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_values(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_values(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -21758,7 +21758,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_values(PyObject *self, PyObject *
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_values" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_values" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (PyObject *)std_map_Sl_std_string_Sc_double_Sg__values(arg1);
@@ -21769,7 +21769,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_items(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_items(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -21782,7 +21782,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_items(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_items" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_items" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (PyObject *)std_map_Sl_std_string_Sc_double_Sg__items(arg1);
@@ -21793,7 +21793,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t___contains__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T___contains__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::key_type *arg2 = 0 ;
@@ -21804,20 +21804,20 @@ SWIGINTERN PyObject *_wrap_map_string_double_t___contains__(PyObject *self, PyOb
   bool result;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "map_string_double_t___contains__", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "map_string_double_T___contains__", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t___contains__" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T___contains__" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t___contains__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T___contains__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t___contains__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T___contains__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -21831,7 +21831,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_key_iterator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_key_iterator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   PyObject **arg2 = (PyObject **) 0 ;
@@ -21846,7 +21846,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_key_iterator(PyObject *self, PyOb
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_key_iterator" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_key_iterator" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (swig::SwigPyIterator *)std_map_Sl_std_string_Sc_double_Sg__key_iterator(arg1,arg2);
@@ -21857,7 +21857,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_value_iterator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_value_iterator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   PyObject **arg2 = (PyObject **) 0 ;
@@ -21872,7 +21872,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_value_iterator(PyObject *self, Py
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_value_iterator" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_value_iterator" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (swig::SwigPyIterator *)std_map_Sl_std_string_Sc_double_Sg__value_iterator(arg1,arg2);
@@ -21883,7 +21883,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_map_string_double_T___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::key_type *arg2 = 0 ;
@@ -21895,17 +21895,17 @@ SWIGINTERN PyObject *_wrap_map_string_double_t___setitem____SWIG_0(PyObject *sel
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t___setitem__" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T___setitem__" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t___setitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T___setitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t___setitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T___setitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -21919,7 +21919,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_map_string_double_T___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::key_type *arg2 = 0 ;
@@ -21935,23 +21935,23 @@ SWIGINTERN PyObject *_wrap_map_string_double_t___setitem____SWIG_1(PyObject *sel
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t___setitem__" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T___setitem__" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t___setitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T___setitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t___setitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T___setitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     arg2 = ptr;
   }
   ecode3 = SWIG_AsVal_double(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "map_string_double_t___setitem__" "', argument " "3"" of type '" "std::map< std::string,double >::mapped_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "map_string_double_T___setitem__" "', argument " "3"" of type '" "std::map< std::string,double >::mapped_type""'");
   } 
   temp3 = static_cast< std::map< std::string,double >::mapped_type >(val3);
   arg3 = &temp3;
@@ -21969,13 +21969,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t___setitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T___setitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "map_string_double_t___setitem__", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "map_string_double_T___setitem__", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -21985,7 +21985,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t___setitem__(PyObject *self, PyObj
       int res = SWIG_AsPtr_std_string(argv[1], (std::string**)(0));
       _v = SWIG_CheckState(res);
       if (_v) {
-        return _wrap_map_string_double_t___setitem____SWIG_0(self, argc, argv);
+        return _wrap_map_string_double_T___setitem____SWIG_0(self, argc, argv);
       }
     }
   }
@@ -22002,14 +22002,14 @@ SWIGINTERN PyObject *_wrap_map_string_double_t___setitem__(PyObject *self, PyObj
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_map_string_double_t___setitem____SWIG_1(self, argc, argv);
+          return _wrap_map_string_double_T___setitem____SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'map_string_double_t___setitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'map_string_double_T___setitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::map< std::string,double >::__setitem__(std::map< std::string,double >::key_type const &)\n"
     "    std::map< std::string,double >::__setitem__(std::map< std::string,double >::key_type const &,std::map< std::string,double >::mapped_type const &)\n");
@@ -22017,7 +22017,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_asdict(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_asdict(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -22030,7 +22030,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_asdict(PyObject *self, PyObject *
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_asdict" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_asdict" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (PyObject *)std_map_Sl_std_string_Sc_double_Sg__asdict(arg1);
@@ -22041,7 +22041,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_map_string_double_t__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
+SWIGINTERN PyObject *_wrap_new_map_string_double_T__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *result = 0 ;
   
@@ -22055,7 +22055,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_map_string_double_t__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_map_string_double_T__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = 0 ;
   int res1 = SWIG_OLDOBJ ;
@@ -22067,10 +22067,10 @@ SWIGINTERN PyObject *_wrap_new_map_string_double_t__SWIG_2(PyObject *self, Py_ss
     std::map< std::string,double,std::less< std::string >,std::allocator< std::pair< std::string const,double > > > *ptr = (std::map< std::string,double,std::less< std::string >,std::allocator< std::pair< std::string const,double > > > *)0;
     res1 = swig::asptr(swig_obj[0], &ptr);
     if (!SWIG_IsOK(res1)) {
-      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_map_string_double_t" "', argument " "1"" of type '" "std::map< std::string,double > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_map_string_double_T" "', argument " "1"" of type '" "std::map< std::string,double > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_map_string_double_t" "', argument " "1"" of type '" "std::map< std::string,double > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_map_string_double_T" "', argument " "1"" of type '" "std::map< std::string,double > const &""'"); 
     }
     arg1 = ptr;
   }
@@ -22084,23 +22084,23 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_map_string_double_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_new_map_string_double_T(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[2] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "new_map_string_double_t", 0, 1, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "new_map_string_double_T", 0, 1, argv))) SWIG_fail;
   --argc;
   if (argc == 0) {
-    return _wrap_new_map_string_double_t__SWIG_1(self, argc, argv);
+    return _wrap_new_map_string_double_T__SWIG_1(self, argc, argv);
   }
   if (argc == 1) {
     int _v = 0;
     int res = SWIG_ConvertPtr(argv[0], 0, SWIGTYPE_p_std__lessT_std__string_t, SWIG_POINTER_NO_NULL | 0);
     _v = SWIG_CheckState(res);
     if (_v) {
-      return _wrap_new_map_string_double_t__SWIG_0(self, argc, argv);
+      return _wrap_new_map_string_double_T__SWIG_0(self, argc, argv);
     }
   }
   if (argc == 1) {
@@ -22108,12 +22108,12 @@ SWIGINTERN PyObject *_wrap_new_map_string_double_t(PyObject *self, PyObject *arg
     int res = swig::asptr(argv[0], (std::map< std::string,double,std::less< std::string >,std::allocator< std::pair< std::string const,double > > >**)(0));
     _v = SWIG_CheckState(res);
     if (_v) {
-      return _wrap_new_map_string_double_t__SWIG_2(self, argc, argv);
+      return _wrap_new_map_string_double_T__SWIG_2(self, argc, argv);
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_map_string_double_t'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_map_string_double_T'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::map< std::string,double >::map(std::less< std::string > const &)\n"
     "    std::map< std::string,double >::map()\n"
@@ -22122,7 +22122,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_empty(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_empty(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -22135,7 +22135,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_empty(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_empty" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_empty" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (bool)((std::map< std::string,double > const *)arg1)->empty();
@@ -22146,7 +22146,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_size(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_size(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -22159,7 +22159,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_size(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_size" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_size" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = ((std::map< std::string,double > const *)arg1)->size();
@@ -22170,7 +22170,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_swap(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_swap(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double > *arg2 = 0 ;
@@ -22181,18 +22181,18 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_swap(PyObject *self, PyObject *ar
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "map_string_double_t_swap", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "map_string_double_T_swap", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_swap" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_swap" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], &argp2, SWIGTYPE_p_std__mapT_std__string_double_t,  0 );
   if (!SWIG_IsOK(res2)) {
-    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t_swap" "', argument " "2"" of type '" "std::map< std::string,double > &""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T_swap" "', argument " "2"" of type '" "std::map< std::string,double > &""'"); 
   }
   if (!argp2) {
-    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t_swap" "', argument " "2"" of type '" "std::map< std::string,double > &""'"); 
+    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T_swap" "', argument " "2"" of type '" "std::map< std::string,double > &""'"); 
   }
   arg2 = reinterpret_cast< std::map< std::string,double > * >(argp2);
   (arg1)->swap(*arg2);
@@ -22203,7 +22203,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_begin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_begin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -22216,7 +22216,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_begin(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_begin" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_begin" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (arg1)->begin();
@@ -22228,7 +22228,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_end(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_end(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -22241,7 +22241,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_end(PyObject *self, PyObject *arg
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_end" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_end" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (arg1)->end();
@@ -22253,7 +22253,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_rbegin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_rbegin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -22266,7 +22266,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_rbegin(PyObject *self, PyObject *
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_rbegin" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_rbegin" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (arg1)->rbegin();
@@ -22278,7 +22278,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_rend(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_rend(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -22291,7 +22291,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_rend(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_rend" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_rend" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (arg1)->rend();
@@ -22303,7 +22303,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_clear(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_clear(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -22315,7 +22315,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_clear(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_clear" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_clear" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   (arg1)->clear();
@@ -22326,7 +22326,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_get_allocator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_get_allocator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -22339,7 +22339,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_get_allocator(PyObject *self, PyO
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_get_allocator" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_get_allocator" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = ((std::map< std::string,double > const *)arg1)->get_allocator();
@@ -22350,7 +22350,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::key_type *arg2 = 0 ;
@@ -22363,17 +22363,17 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_erase__SWIG_0(PyObject *self, Py_
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_erase" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_erase" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t_erase" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T_erase" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t_erase" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T_erase" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -22387,7 +22387,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_count(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_count(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::key_type *arg2 = 0 ;
@@ -22398,20 +22398,20 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_count(PyObject *self, PyObject *a
   std::map< std::string,double >::size_type result;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "map_string_double_t_count", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "map_string_double_T_count", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_count" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_count" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t_count" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T_count" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t_count" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T_count" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -22425,7 +22425,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::iterator arg2 ;
@@ -22438,18 +22438,18 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_erase__SWIG_1(PyObject *self, Py_
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_erase" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_erase" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_t_erase" "', argument " "2"" of type '" "std::map< std::string,double >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_T_erase" "', argument " "2"" of type '" "std::map< std::string,double >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::map< std::string,double >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::map< std::string,double >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_t_erase" "', argument " "2"" of type '" "std::map< std::string,double >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_T_erase" "', argument " "2"" of type '" "std::map< std::string,double >::iterator""'");
     }
   }
   std_map_Sl_std_string_Sc_double_Sg__erase__SWIG_1(arg1,SWIG_STD_MOVE(arg2));
@@ -22460,7 +22460,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_erase__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_erase__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::iterator arg2 ;
@@ -22476,29 +22476,29 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_erase__SWIG_2(PyObject *self, Py_
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_erase" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_erase" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_t_erase" "', argument " "2"" of type '" "std::map< std::string,double >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_T_erase" "', argument " "2"" of type '" "std::map< std::string,double >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::map< std::string,double >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::map< std::string,double >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_t_erase" "', argument " "2"" of type '" "std::map< std::string,double >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_T_erase" "', argument " "2"" of type '" "std::map< std::string,double >::iterator""'");
     }
   }
   res3 = SWIG_ConvertPtr(swig_obj[2], SWIG_as_voidptrptr(&iter3), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res3) || !iter3) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_t_erase" "', argument " "3"" of type '" "std::map< std::string,double >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_T_erase" "', argument " "3"" of type '" "std::map< std::string,double >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::map< std::string,double >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::map< std::string,double >::iterator > *>(iter3);
     if (iter_t) {
       arg3 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_t_erase" "', argument " "3"" of type '" "std::map< std::string,double >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_T_erase" "', argument " "3"" of type '" "std::map< std::string,double >::iterator""'");
     }
   }
   std_map_Sl_std_string_Sc_double_Sg__erase__SWIG_2(arg1,SWIG_STD_MOVE(arg2),SWIG_STD_MOVE(arg3));
@@ -22509,13 +22509,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_erase(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_erase(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "map_string_double_t_erase", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "map_string_double_T_erase", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -22526,7 +22526,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_erase(PyObject *self, PyObject *a
       int res = SWIG_ConvertPtr(argv[1], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
       _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::map< std::string,double >::iterator > *>(iter) != 0));
       if (_v) {
-        return _wrap_map_string_double_t_erase__SWIG_1(self, argc, argv);
+        return _wrap_map_string_double_T_erase__SWIG_1(self, argc, argv);
       }
     }
   }
@@ -22538,7 +22538,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_erase(PyObject *self, PyObject *a
       int res = SWIG_AsPtr_std_string(argv[1], (std::string**)(0));
       _v = SWIG_CheckState(res);
       if (_v) {
-        return _wrap_map_string_double_t_erase__SWIG_0(self, argc, argv);
+        return _wrap_map_string_double_T_erase__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -22555,14 +22555,14 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_erase(PyObject *self, PyObject *a
         int res = SWIG_ConvertPtr(argv[2], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
         _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::map< std::string,double >::iterator > *>(iter) != 0));
         if (_v) {
-          return _wrap_map_string_double_t_erase__SWIG_2(self, argc, argv);
+          return _wrap_map_string_double_T_erase__SWIG_2(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'map_string_double_t_erase'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'map_string_double_T_erase'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::map< std::string,double >::erase(std::map< std::string,double >::key_type const &)\n"
     "    std::map< std::string,double >::erase(std::map< std::string,double >::iterator)\n"
@@ -22571,7 +22571,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_find(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_find(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::key_type *arg2 = 0 ;
@@ -22582,20 +22582,20 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_find(PyObject *self, PyObject *ar
   std::map< std::string,double >::iterator result;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "map_string_double_t_find", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "map_string_double_T_find", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_find" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_find" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t_find" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T_find" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t_find" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T_find" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -22610,7 +22610,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_lower_bound(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_lower_bound(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::key_type *arg2 = 0 ;
@@ -22621,20 +22621,20 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_lower_bound(PyObject *self, PyObj
   std::map< std::string,double >::iterator result;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "map_string_double_t_lower_bound", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "map_string_double_T_lower_bound", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_lower_bound" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_lower_bound" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t_lower_bound" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T_lower_bound" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t_lower_bound" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T_lower_bound" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -22649,7 +22649,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_upper_bound(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_upper_bound(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::key_type *arg2 = 0 ;
@@ -22660,20 +22660,20 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_upper_bound(PyObject *self, PyObj
   std::map< std::string,double >::iterator result;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "map_string_double_t_upper_bound", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "map_string_double_T_upper_bound", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_upper_bound" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_upper_bound" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t_upper_bound" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T_upper_bound" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t_upper_bound" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T_upper_bound" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -22688,7 +22688,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_delete_map_string_double_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_delete_map_string_double_T(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -22700,7 +22700,7 @@ SWIGINTERN PyObject *_wrap_delete_map_string_double_t(PyObject *self, PyObject *
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, SWIG_POINTER_DISOWN |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_map_string_double_t" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_map_string_double_T" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
@@ -22721,18 +22721,18 @@ fail:
 }
 
 
-SWIGINTERN PyObject *map_string_double_t_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *map_string_double_T_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   PyObject *obj;
   if (!SWIG_Python_UnpackTuple(args, "swigregister", 1, 1, &obj)) return NULL;
   SWIG_TypeNewClientData(SWIGTYPE_p_std__mapT_std__string_double_t, SWIG_NewClientData(obj));
   return SWIG_Py_Void();
 }
 
-SWIGINTERN PyObject *map_string_double_t_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *map_string_double_T_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   return SWIG_Python_InitShadowInstance(args);
 }
 
-SWIGINTERN PyObject *_wrap_new_pvacuum_double_t__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
+SWIGINTERN PyObject *_wrap_new_pvacuum_double_T__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
   PyObject *resultobj = 0;
   std::pair< double,double > *result = 0 ;
   
@@ -22746,7 +22746,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_pvacuum_double_t__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_pvacuum_double_T__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   double arg1 ;
   double arg2 ;
@@ -22760,12 +22760,12 @@ SWIGINTERN PyObject *_wrap_new_pvacuum_double_t__SWIG_1(PyObject *self, Py_ssize
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   ecode1 = SWIG_AsVal_double(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_pvacuum_double_t" "', argument " "1"" of type '" "double""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_pvacuum_double_T" "', argument " "1"" of type '" "double""'");
   } 
   arg1 = static_cast< double >(val1);
   ecode2 = SWIG_AsVal_double(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "new_pvacuum_double_t" "', argument " "2"" of type '" "double""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "new_pvacuum_double_T" "', argument " "2"" of type '" "double""'");
   } 
   arg2 = static_cast< double >(val2);
   result = (std::pair< double,double > *)new std::pair< double,double >(arg1,arg2);
@@ -22776,7 +22776,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_pvacuum_double_t__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_pvacuum_double_T__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::pair< double,double > *arg1 = 0 ;
   int res1 = SWIG_OLDOBJ ;
@@ -22788,10 +22788,10 @@ SWIGINTERN PyObject *_wrap_new_pvacuum_double_t__SWIG_2(PyObject *self, Py_ssize
     std::pair< double,double > *ptr = (std::pair< double,double > *)0;
     res1 = swig::asptr(swig_obj[0], &ptr);
     if (!SWIG_IsOK(res1)) {
-      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_pvacuum_double_t" "', argument " "1"" of type '" "std::pair< double,double > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_pvacuum_double_T" "', argument " "1"" of type '" "std::pair< double,double > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_pvacuum_double_t" "', argument " "1"" of type '" "std::pair< double,double > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_pvacuum_double_T" "', argument " "1"" of type '" "std::pair< double,double > const &""'"); 
     }
     arg1 = ptr;
   }
@@ -22805,23 +22805,23 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_pvacuum_double_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_new_pvacuum_double_T(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "new_pvacuum_double_t", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "new_pvacuum_double_T", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 0) {
-    return _wrap_new_pvacuum_double_t__SWIG_0(self, argc, argv);
+    return _wrap_new_pvacuum_double_T__SWIG_0(self, argc, argv);
   }
   if (argc == 1) {
     int _v = 0;
     int res = swig::asptr(argv[0], (std::pair< double,double >**)(0));
     _v = SWIG_CheckState(res);
     if (_v) {
-      return _wrap_new_pvacuum_double_t__SWIG_2(self, argc, argv);
+      return _wrap_new_pvacuum_double_T__SWIG_2(self, argc, argv);
     }
   }
   if (argc == 2) {
@@ -22836,13 +22836,13 @@ SWIGINTERN PyObject *_wrap_new_pvacuum_double_t(PyObject *self, PyObject *args)
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_new_pvacuum_double_t__SWIG_1(self, argc, argv);
+        return _wrap_new_pvacuum_double_T__SWIG_1(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_pvacuum_double_t'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_pvacuum_double_T'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::pair< double,double >::pair()\n"
     "    std::pair< double,double >::pair(double,double)\n"
@@ -22851,7 +22851,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_pvacuum_double_t_first_set(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_pvacuum_double_T_first_set(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::pair< double,double > *arg1 = (std::pair< double,double > *) 0 ;
   double arg2 ;
@@ -22862,15 +22862,15 @@ SWIGINTERN PyObject *_wrap_pvacuum_double_t_first_set(PyObject *self, PyObject *
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "pvacuum_double_t_first_set", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "pvacuum_double_T_first_set", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__pairT_double_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "pvacuum_double_t_first_set" "', argument " "1"" of type '" "std::pair< double,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "pvacuum_double_T_first_set" "', argument " "1"" of type '" "std::pair< double,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::pair< double,double > * >(argp1);
   ecode2 = SWIG_AsVal_double(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "pvacuum_double_t_first_set" "', argument " "2"" of type '" "double""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "pvacuum_double_T_first_set" "', argument " "2"" of type '" "double""'");
   } 
   arg2 = static_cast< double >(val2);
   if (arg1) (arg1)->first = arg2;
@@ -22881,7 +22881,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_pvacuum_double_t_first_get(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_pvacuum_double_T_first_get(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::pair< double,double > *arg1 = (std::pair< double,double > *) 0 ;
   void *argp1 = 0 ;
@@ -22894,7 +22894,7 @@ SWIGINTERN PyObject *_wrap_pvacuum_double_t_first_get(PyObject *self, PyObject *
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__pairT_double_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "pvacuum_double_t_first_get" "', argument " "1"" of type '" "std::pair< double,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "pvacuum_double_T_first_get" "', argument " "1"" of type '" "std::pair< double,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::pair< double,double > * >(argp1);
   result = (double) ((arg1)->first);
@@ -22905,7 +22905,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_pvacuum_double_t_second_set(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_pvacuum_double_T_second_set(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::pair< double,double > *arg1 = (std::pair< double,double > *) 0 ;
   double arg2 ;
@@ -22916,15 +22916,15 @@ SWIGINTERN PyObject *_wrap_pvacuum_double_t_second_set(PyObject *self, PyObject
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "pvacuum_double_t_second_set", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "pvacuum_double_T_second_set", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__pairT_double_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "pvacuum_double_t_second_set" "', argument " "1"" of type '" "std::pair< double,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "pvacuum_double_T_second_set" "', argument " "1"" of type '" "std::pair< double,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::pair< double,double > * >(argp1);
   ecode2 = SWIG_AsVal_double(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "pvacuum_double_t_second_set" "', argument " "2"" of type '" "double""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "pvacuum_double_T_second_set" "', argument " "2"" of type '" "double""'");
   } 
   arg2 = static_cast< double >(val2);
   if (arg1) (arg1)->second = arg2;
@@ -22935,7 +22935,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_pvacuum_double_t_second_get(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_pvacuum_double_T_second_get(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::pair< double,double > *arg1 = (std::pair< double,double > *) 0 ;
   void *argp1 = 0 ;
@@ -22948,7 +22948,7 @@ SWIGINTERN PyObject *_wrap_pvacuum_double_t_second_get(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__pairT_double_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "pvacuum_double_t_second_get" "', argument " "1"" of type '" "std::pair< double,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "pvacuum_double_T_second_get" "', argument " "1"" of type '" "std::pair< double,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::pair< double,double > * >(argp1);
   result = (double) ((arg1)->second);
@@ -22959,7 +22959,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_delete_pvacuum_double_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_delete_pvacuum_double_T(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::pair< double,double > *arg1 = (std::pair< double,double > *) 0 ;
   void *argp1 = 0 ;
@@ -22971,7 +22971,7 @@ SWIGINTERN PyObject *_wrap_delete_pvacuum_double_t(PyObject *self, PyObject *arg
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__pairT_double_double_t, SWIG_POINTER_DISOWN |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_pvacuum_double_t" "', argument " "1"" of type '" "std::pair< double,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_pvacuum_double_T" "', argument " "1"" of type '" "std::pair< double,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::pair< double,double > * >(argp1);
   {
@@ -22992,18 +22992,18 @@ fail:
 }
 
 
-SWIGINTERN PyObject *pvacuum_double_t_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *pvacuum_double_T_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   PyObject *obj;
   if (!SWIG_Python_UnpackTuple(args, "swigregister", 1, 1, &obj)) return NULL;
   SWIG_TypeNewClientData(SWIGTYPE_p_std__pairT_double_double_t, SWIG_NewClientData(obj));
   return SWIG_Py_Void();
 }
 
-SWIGINTERN PyObject *pvacuum_double_t_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *pvacuum_double_T_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   return SWIG_Python_InitShadowInstance(args);
 }
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_iterator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_iterator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   PyObject **arg2 = (PyObject **) 0 ;
@@ -23018,7 +23018,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_iterator(PyObject *self, PyOb
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_iterator" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_iterator" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = (swig::SwigPyIterator *)std_vector_Sl_std_pair_Sl_double_Sc_double_Sg__Sg__iterator(arg1,arg2);
@@ -23029,7 +23029,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___nonzero__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___nonzero__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -23042,7 +23042,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___nonzero__(PyObject *self, P
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___nonzero__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___nonzero__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = (bool)std_vector_Sl_std_pair_Sl_double_Sc_double_Sg__Sg____nonzero__((std::vector< std::pair< double,double > > const *)arg1);
@@ -23053,7 +23053,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___bool__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___bool__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -23066,7 +23066,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___bool__(PyObject *self, PyOb
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___bool__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___bool__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = (bool)std_vector_Sl_std_pair_Sl_double_Sc_double_Sg__Sg____bool__((std::vector< std::pair< double,double > > const *)arg1);
@@ -23077,7 +23077,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___len__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___len__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -23090,7 +23090,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___len__(PyObject *self, PyObj
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___len__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___len__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = std_vector_Sl_std_pair_Sl_double_Sc_double_Sg__Sg____len__((std::vector< std::pair< double,double > > const *)arg1);
@@ -23101,7 +23101,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___getslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___getslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::difference_type arg2 ;
@@ -23116,20 +23116,20 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___getslice__(PyObject *self,
   std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > *result = 0 ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t___getslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T___getslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___getslice__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___getslice__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_t___getslice__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_T___getslice__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::pair< double,double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_pvacuum_double_t___getslice__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_pvacuum_double_T___getslice__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::pair< double,double > >::difference_type >(val3);
   try {
@@ -23146,7 +23146,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::difference_type arg2 ;
@@ -23162,17 +23162,17 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setslice____SWIG_0(PyObject
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___setslice__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___setslice__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_t___setslice__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_T___setslice__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::pair< double,double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_pvacuum_double_t___setslice__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_pvacuum_double_T___setslice__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::pair< double,double > >::difference_type >(val3);
   try {
@@ -23189,7 +23189,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::difference_type arg2 ;
@@ -23207,27 +23207,27 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setslice____SWIG_1(PyObject
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___setslice__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___setslice__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_t___setslice__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_T___setslice__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::pair< double,double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_pvacuum_double_t___setslice__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_pvacuum_double_T___setslice__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::pair< double,double > >::difference_type >(val3);
   {
     std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > *ptr = (std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > *)0;
     res4 = swig::asptr(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_pvacuum_double_t___setslice__" "', argument " "4"" of type '" "std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_pvacuum_double_T___setslice__" "', argument " "4"" of type '" "std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_t___setslice__" "', argument " "4"" of type '" "std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_T___setslice__" "', argument " "4"" of type '" "std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > const &""'"); 
     }
     arg4 = ptr;
   }
@@ -23247,13 +23247,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___setslice__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t___setslice__", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T___setslice__", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -23270,7 +23270,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setslice__(PyObject *self,
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_pvacuum_double_t___setslice____SWIG_0(self, argc, argv);
+          return _wrap_vector_pvacuum_double_T___setslice____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -23293,7 +23293,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setslice__(PyObject *self,
           int res = swig::asptr(argv[3], (std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > >**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vector_pvacuum_double_t___setslice____SWIG_1(self, argc, argv);
+            return _wrap_vector_pvacuum_double_T___setslice____SWIG_1(self, argc, argv);
           }
         }
       }
@@ -23301,7 +23301,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setslice__(PyObject *self,
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_t___setslice__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_T___setslice__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::pair< double,double > >::__setslice__(std::vector< std::pair< double,double > >::difference_type,std::vector< std::pair< double,double > >::difference_type)\n"
     "    std::vector< std::pair< double,double > >::__setslice__(std::vector< std::pair< double,double > >::difference_type,std::vector< std::pair< double,double > >::difference_type,std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > const &)\n");
@@ -23309,7 +23309,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___delslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___delslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::difference_type arg2 ;
@@ -23323,20 +23323,20 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___delslice__(PyObject *self,
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t___delslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T___delslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___delslice__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___delslice__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_t___delslice__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_T___delslice__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::pair< double,double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_pvacuum_double_t___delslice__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_pvacuum_double_T___delslice__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::pair< double,double > >::difference_type >(val3);
   try {
@@ -23353,7 +23353,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::difference_type arg2 ;
@@ -23366,12 +23366,12 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___delitem____SWIG_0(PyObject
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___delitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___delitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_t___delitem__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_T___delitem__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::pair< double,double > >::difference_type >(val2);
   try {
@@ -23388,7 +23388,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -23400,12 +23400,12 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___getitem____SWIG_0(PyObject
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___getitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___getitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -23423,7 +23423,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -23436,12 +23436,12 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setitem____SWIG_0(PyObject
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___setitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___setitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -23449,10 +23449,10 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setitem____SWIG_0(PyObject
     std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > *ptr = (std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_pvacuum_double_t___setitem__" "', argument " "3"" of type '" "std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_pvacuum_double_T___setitem__" "', argument " "3"" of type '" "std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_t___setitem__" "', argument " "3"" of type '" "std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_T___setitem__" "', argument " "3"" of type '" "std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > const &""'"); 
     }
     arg3 = ptr;
   }
@@ -23472,7 +23472,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -23483,12 +23483,12 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setitem____SWIG_1(PyObject
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___setitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___setitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -23506,7 +23506,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -23517,12 +23517,12 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___delitem____SWIG_1(PyObject
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___delitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___delitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -23540,13 +23540,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___delitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___delitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t___delitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T___delitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -23557,7 +23557,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___delitem__(PyObject *self, P
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_pvacuum_double_t___delitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_pvacuum_double_T___delitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -23571,13 +23571,13 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___delitem__(PyObject *self, P
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_pvacuum_double_t___delitem____SWIG_0(self, argc, argv);
+        return _wrap_vector_pvacuum_double_T___delitem____SWIG_0(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_t___delitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_T___delitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::pair< double,double > >::__delitem__(std::vector< std::pair< double,double > >::difference_type)\n"
     "    std::vector< std::pair< double,double > >::__delitem__(SWIGPY_SLICEOBJECT *)\n");
@@ -23585,7 +23585,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::difference_type arg2 ;
@@ -23599,12 +23599,12 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___getitem____SWIG_1(PyObject
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___getitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___getitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_t___getitem__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_T___getitem__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::pair< double,double > >::difference_type >(val2);
   try {
@@ -23620,13 +23620,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___getitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___getitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t___getitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T___getitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -23637,7 +23637,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___getitem__(PyObject *self, P
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_pvacuum_double_t___getitem____SWIG_0(self, argc, argv);
+        return _wrap_vector_pvacuum_double_T___getitem____SWIG_0(self, argc, argv);
       }
     }
   }
@@ -23651,13 +23651,13 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___getitem__(PyObject *self, P
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_pvacuum_double_t___getitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_pvacuum_double_T___getitem____SWIG_1(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_t___getitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_T___getitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::pair< double,double > >::__getitem__(SWIGPY_SLICEOBJECT *)\n"
     "    std::vector< std::pair< double,double > >::__getitem__(std::vector< std::pair< double,double > >::difference_type) const\n");
@@ -23665,7 +23665,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::difference_type arg2 ;
@@ -23680,22 +23680,22 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setitem____SWIG_2(PyObject
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___setitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___setitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_t___setitem__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_T___setitem__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::pair< double,double > >::difference_type >(val2);
   {
     std::pair< double,double > *ptr = (std::pair< double,double > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_pvacuum_double_t___setitem__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_pvacuum_double_T___setitem__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_t___setitem__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_T___setitem__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -23713,13 +23713,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___setitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t___setitem__", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T___setitem__", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -23730,7 +23730,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setitem__(PyObject *self, P
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_pvacuum_double_t___setitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_pvacuum_double_T___setitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -23746,7 +23746,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setitem__(PyObject *self, P
         int res = swig::asptr(argv[2], (std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vector_pvacuum_double_t___setitem____SWIG_0(self, argc, argv);
+          return _wrap_vector_pvacuum_double_T___setitem____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -23764,14 +23764,14 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setitem__(PyObject *self, P
         int res = swig::asptr(argv[2], (std::pair< double,double >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vector_pvacuum_double_t___setitem____SWIG_2(self, argc, argv);
+          return _wrap_vector_pvacuum_double_T___setitem____SWIG_2(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_t___setitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_T___setitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::pair< double,double > >::__setitem__(SWIGPY_SLICEOBJECT *,std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > const &)\n"
     "    std::vector< std::pair< double,double > >::__setitem__(SWIGPY_SLICEOBJECT *)\n"
@@ -23780,7 +23780,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_pop(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_pop(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -23793,7 +23793,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_pop(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_pop" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_pop" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   try {
@@ -23808,7 +23808,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_append(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_append(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::value_type *arg2 = 0 ;
@@ -23818,20 +23818,20 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_append(PyObject *self, PyObje
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t_append", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T_append", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_append" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_append" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   {
     std::pair< double,double > *ptr = (std::pair< double,double > *)0;
     res2 = swig::asptr(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_pvacuum_double_t_append" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_pvacuum_double_T_append" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_t_append" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_T_append" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -23845,7 +23845,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_t__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
+SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_T__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *result = 0 ;
   
@@ -23859,7 +23859,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_t__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_T__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = 0 ;
   int res1 = SWIG_OLDOBJ ;
@@ -23871,10 +23871,10 @@ SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_t__SWIG_1(PyObject *self, P
     std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > *ptr = (std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > *)0;
     res1 = swig::asptr(swig_obj[0], &ptr);
     if (!SWIG_IsOK(res1)) {
-      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vector_pvacuum_double_t" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vector_pvacuum_double_T" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_pvacuum_double_t" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_pvacuum_double_T" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const &""'"); 
     }
     arg1 = ptr;
   }
@@ -23888,7 +23888,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_empty(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_empty(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -23901,7 +23901,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_empty(PyObject *self, PyObjec
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_empty" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_empty" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = (bool)((std::vector< std::pair< double,double > > const *)arg1)->empty();
@@ -23912,7 +23912,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_size(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_size(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -23925,7 +23925,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_size(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_size" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_size" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = ((std::vector< std::pair< double,double > > const *)arg1)->size();
@@ -23936,7 +23936,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_swap(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_swap(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > > *arg2 = 0 ;
@@ -23947,18 +23947,18 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_swap(PyObject *self, PyObject
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t_swap", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T_swap", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_swap" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_swap" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], &argp2, SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t,  0 );
   if (!SWIG_IsOK(res2)) {
-    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_pvacuum_double_t_swap" "', argument " "2"" of type '" "std::vector< std::pair< double,double > > &""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_pvacuum_double_T_swap" "', argument " "2"" of type '" "std::vector< std::pair< double,double > > &""'"); 
   }
   if (!argp2) {
-    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_t_swap" "', argument " "2"" of type '" "std::vector< std::pair< double,double > > &""'"); 
+    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_T_swap" "', argument " "2"" of type '" "std::vector< std::pair< double,double > > &""'"); 
   }
   arg2 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp2);
   (arg1)->swap(*arg2);
@@ -23969,7 +23969,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_begin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_begin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -23982,7 +23982,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_begin(PyObject *self, PyObjec
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_begin" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_begin" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = (arg1)->begin();
@@ -23994,7 +23994,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_end(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_end(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -24007,7 +24007,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_end(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_end" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_end" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = (arg1)->end();
@@ -24019,7 +24019,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_rbegin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_rbegin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -24032,7 +24032,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_rbegin(PyObject *self, PyObje
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_rbegin" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_rbegin" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = (arg1)->rbegin();
@@ -24044,7 +24044,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_rend(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_rend(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -24057,7 +24057,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_rend(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_rend" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_rend" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = (arg1)->rend();
@@ -24069,7 +24069,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_clear(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_clear(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -24081,7 +24081,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_clear(PyObject *self, PyObjec
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_clear" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_clear" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   (arg1)->clear();
@@ -24092,7 +24092,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_get_allocator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_get_allocator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -24105,7 +24105,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_get_allocator(PyObject *self,
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_get_allocator" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_get_allocator" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = ((std::vector< std::pair< double,double > > const *)arg1)->get_allocator();
@@ -24116,7 +24116,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_t__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_T__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > >::size_type arg1 ;
   size_t val1 ;
@@ -24127,7 +24127,7 @@ SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_t__SWIG_2(PyObject *self, P
   if ((nobjs < 1) || (nobjs > 1)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_pvacuum_double_t" "', argument " "1"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_pvacuum_double_T" "', argument " "1"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
   } 
   arg1 = static_cast< std::vector< std::pair< double,double > >::size_type >(val1);
   result = (std::vector< std::pair< double,double > > *)new std::vector< std::pair< double,double > >(arg1);
@@ -24138,7 +24138,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_pop_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_pop_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -24150,7 +24150,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_pop_back(PyObject *self, PyOb
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_pop_back" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_pop_back" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   (arg1)->pop_back();
@@ -24161,7 +24161,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::size_type arg2 ;
@@ -24174,12 +24174,12 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_resize__SWIG_0(PyObject *self
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_resize" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_resize" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_t_resize" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_T_resize" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::pair< double,double > >::size_type >(val2);
   (arg1)->resize(arg2);
@@ -24190,7 +24190,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::iterator arg2 ;
@@ -24204,18 +24204,18 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_erase__SWIG_0(PyObject *self,
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_erase" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_erase" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t_erase" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T_erase" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t_erase" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T_erase" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
     }
   }
   result = std_vector_Sl_std_pair_Sl_double_Sc_double_Sg__Sg__erase__SWIG_0(arg1,SWIG_STD_MOVE(arg2));
@@ -24227,7 +24227,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::iterator arg2 ;
@@ -24244,29 +24244,29 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_erase__SWIG_1(PyObject *self,
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_erase" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_erase" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t_erase" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T_erase" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t_erase" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T_erase" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
     }
   }
   res3 = SWIG_ConvertPtr(swig_obj[2], SWIG_as_voidptrptr(&iter3), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res3) || !iter3) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t_erase" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T_erase" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *>(iter3);
     if (iter_t) {
       arg3 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t_erase" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T_erase" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
     }
   }
   result = std_vector_Sl_std_pair_Sl_double_Sc_double_Sg__Sg__erase__SWIG_1(arg1,SWIG_STD_MOVE(arg2),SWIG_STD_MOVE(arg3));
@@ -24278,13 +24278,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_erase(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_erase(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t_erase", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T_erase", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -24295,7 +24295,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_erase(PyObject *self, PyObjec
       int res = SWIG_ConvertPtr(argv[1], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
       _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *>(iter) != 0));
       if (_v) {
-        return _wrap_vector_pvacuum_double_t_erase__SWIG_0(self, argc, argv);
+        return _wrap_vector_pvacuum_double_T_erase__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -24312,14 +24312,14 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_erase(PyObject *self, PyObjec
         int res = SWIG_ConvertPtr(argv[2], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
         _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *>(iter) != 0));
         if (_v) {
-          return _wrap_vector_pvacuum_double_t_erase__SWIG_1(self, argc, argv);
+          return _wrap_vector_pvacuum_double_T_erase__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_t_erase'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_T_erase'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::pair< double,double > >::erase(std::vector< std::pair< double,double > >::iterator)\n"
     "    std::vector< std::pair< double,double > >::erase(std::vector< std::pair< double,double > >::iterator,std::vector< std::pair< double,double > >::iterator)\n");
@@ -24327,7 +24327,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_t__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_T__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > >::size_type arg1 ;
   std::vector< std::pair< double,double > >::value_type *arg2 = 0 ;
@@ -24340,17 +24340,17 @@ SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_t__SWIG_3(PyObject *self, P
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_pvacuum_double_t" "', argument " "1"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_pvacuum_double_T" "', argument " "1"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
   } 
   arg1 = static_cast< std::vector< std::pair< double,double > >::size_type >(val1);
   {
     std::pair< double,double > *ptr = (std::pair< double,double > *)0;
     res2 = swig::asptr(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "new_vector_pvacuum_double_t" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "new_vector_pvacuum_double_T" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_pvacuum_double_t" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_pvacuum_double_T" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -24364,16 +24364,16 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_T(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vector_pvacuum_double_t", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vector_pvacuum_double_T", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 0) {
-    return _wrap_new_vector_pvacuum_double_t__SWIG_0(self, argc, argv);
+    return _wrap_new_vector_pvacuum_double_T__SWIG_0(self, argc, argv);
   }
   if (argc == 1) {
     int _v = 0;
@@ -24382,7 +24382,7 @@ SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_t(PyObject *self, PyObject
       _v = SWIG_CheckState(res);
     }
     if (_v) {
-      return _wrap_new_vector_pvacuum_double_t__SWIG_2(self, argc, argv);
+      return _wrap_new_vector_pvacuum_double_T__SWIG_2(self, argc, argv);
     }
   }
   if (argc == 1) {
@@ -24390,7 +24390,7 @@ SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_t(PyObject *self, PyObject
     int res = swig::asptr(argv[0], (std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > >**)(0));
     _v = SWIG_CheckState(res);
     if (_v) {
-      return _wrap_new_vector_pvacuum_double_t__SWIG_1(self, argc, argv);
+      return _wrap_new_vector_pvacuum_double_T__SWIG_1(self, argc, argv);
     }
   }
   if (argc == 2) {
@@ -24403,13 +24403,13 @@ SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_t(PyObject *self, PyObject
       int res = swig::asptr(argv[1], (std::pair< double,double >**)(0));
       _v = SWIG_CheckState(res);
       if (_v) {
-        return _wrap_new_vector_pvacuum_double_t__SWIG_3(self, argc, argv);
+        return _wrap_new_vector_pvacuum_double_T__SWIG_3(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vector_pvacuum_double_t'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vector_pvacuum_double_T'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::pair< double,double > >::vector()\n"
     "    std::vector< std::pair< double,double > >::vector(std::vector< std::pair< double,double > > const &)\n"
@@ -24419,7 +24419,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_push_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_push_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::value_type *arg2 = 0 ;
@@ -24429,20 +24429,20 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_push_back(PyObject *self, PyO
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t_push_back", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T_push_back", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_push_back" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_push_back" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   {
     std::pair< double,double > *ptr = (std::pair< double,double > *)0;
     res2 = swig::asptr(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_pvacuum_double_t_push_back" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_pvacuum_double_T_push_back" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_t_push_back" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_T_push_back" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -24456,7 +24456,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_front(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_front(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -24469,7 +24469,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_front(PyObject *self, PyObjec
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_front" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_front" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = (std::vector< std::pair< double,double > >::value_type *) &((std::vector< std::pair< double,double > > const *)arg1)->front();
@@ -24481,7 +24481,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -24494,7 +24494,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_back(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_back" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_back" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = (std::vector< std::pair< double,double > >::value_type *) &((std::vector< std::pair< double,double > > const *)arg1)->back();
@@ -24506,7 +24506,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_assign(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_assign(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::size_type arg2 ;
@@ -24519,25 +24519,25 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_assign(PyObject *self, PyObje
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t_assign", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T_assign", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_assign" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_assign" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_t_assign" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_T_assign" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::pair< double,double > >::size_type >(val2);
   {
     std::pair< double,double > *ptr = (std::pair< double,double > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_pvacuum_double_t_assign" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_pvacuum_double_T_assign" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_t_assign" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_T_assign" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -24551,7 +24551,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::size_type arg2 ;
@@ -24566,22 +24566,22 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_resize__SWIG_1(PyObject *self
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_resize" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_resize" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_t_resize" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_T_resize" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::pair< double,double > >::size_type >(val2);
   {
     std::pair< double,double > *ptr = (std::pair< double,double > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_pvacuum_double_t_resize" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_pvacuum_double_T_resize" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_t_resize" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_T_resize" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -24595,13 +24595,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_resize(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_resize(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t_resize", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T_resize", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -24613,7 +24613,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_resize(PyObject *self, PyObje
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_pvacuum_double_t_resize__SWIG_0(self, argc, argv);
+        return _wrap_vector_pvacuum_double_T_resize__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -24630,14 +24630,14 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_resize(PyObject *self, PyObje
         int res = swig::asptr(argv[2], (std::pair< double,double >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vector_pvacuum_double_t_resize__SWIG_1(self, argc, argv);
+          return _wrap_vector_pvacuum_double_T_resize__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_t_resize'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_T_resize'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::pair< double,double > >::resize(std::vector< std::pair< double,double > >::size_type)\n"
     "    std::vector< std::pair< double,double > >::resize(std::vector< std::pair< double,double > >::size_type,std::vector< std::pair< double,double > >::value_type const &)\n");
@@ -24645,7 +24645,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::iterator arg2 ;
@@ -24661,28 +24661,28 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_insert__SWIG_0(PyObject *self
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_insert" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_insert" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t_insert" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T_insert" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t_insert" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T_insert" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
     }
   }
   {
     std::pair< double,double > *ptr = (std::pair< double,double > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_pvacuum_double_t_insert" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_pvacuum_double_T_insert" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_t_insert" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_T_insert" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -24697,7 +24697,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::iterator arg2 ;
@@ -24715,33 +24715,33 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_insert__SWIG_1(PyObject *self
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_insert" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_insert" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t_insert" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T_insert" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t_insert" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T_insert" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_size_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_pvacuum_double_t_insert" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_pvacuum_double_T_insert" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
   } 
   arg3 = static_cast< std::vector< std::pair< double,double > >::size_type >(val3);
   {
     std::pair< double,double > *ptr = (std::pair< double,double > *)0;
     res4 = swig::asptr(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_pvacuum_double_t_insert" "', argument " "4"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_pvacuum_double_T_insert" "', argument " "4"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_t_insert" "', argument " "4"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_T_insert" "', argument " "4"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     arg4 = ptr;
   }
@@ -24755,13 +24755,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_insert(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_insert(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t_insert", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T_insert", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -24775,7 +24775,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_insert(PyObject *self, PyObje
         int res = swig::asptr(argv[2], (std::pair< double,double >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vector_pvacuum_double_t_insert__SWIG_0(self, argc, argv);
+          return _wrap_vector_pvacuum_double_T_insert__SWIG_0(self, argc, argv);
         }
       }
     }
@@ -24797,7 +24797,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_insert(PyObject *self, PyObje
           int res = swig::asptr(argv[3], (std::pair< double,double >**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vector_pvacuum_double_t_insert__SWIG_1(self, argc, argv);
+            return _wrap_vector_pvacuum_double_T_insert__SWIG_1(self, argc, argv);
           }
         }
       }
@@ -24805,7 +24805,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_insert(PyObject *self, PyObje
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_t_insert'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_T_insert'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::pair< double,double > >::insert(std::vector< std::pair< double,double > >::iterator,std::vector< std::pair< double,double > >::value_type const &)\n"
     "    std::vector< std::pair< double,double > >::insert(std::vector< std::pair< double,double > >::iterator,std::vector< std::pair< double,double > >::size_type,std::vector< std::pair< double,double > >::value_type const &)\n");
@@ -24813,7 +24813,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_reserve(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_reserve(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::size_type arg2 ;
@@ -24824,15 +24824,15 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_reserve(PyObject *self, PyObj
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t_reserve", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T_reserve", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_reserve" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_reserve" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_t_reserve" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_T_reserve" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::pair< double,double > >::size_type >(val2);
   (arg1)->reserve(arg2);
@@ -24843,7 +24843,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_capacity(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_capacity(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -24856,7 +24856,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_capacity(PyObject *self, PyOb
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_capacity" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_capacity" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = ((std::vector< std::pair< double,double > > const *)arg1)->capacity();
@@ -24867,7 +24867,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_delete_vector_pvacuum_double_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_delete_vector_pvacuum_double_T(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -24879,7 +24879,7 @@ SWIGINTERN PyObject *_wrap_delete_vector_pvacuum_double_t(PyObject *self, PyObje
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, SWIG_POINTER_DISOWN |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vector_pvacuum_double_t" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vector_pvacuum_double_T" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   {
@@ -24900,14 +24900,14 @@ fail:
 }
 
 
-SWIGINTERN PyObject *vector_pvacuum_double_t_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vector_pvacuum_double_T_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   PyObject *obj;
   if (!SWIG_Python_UnpackTuple(args, "swigregister", 1, 1, &obj)) return NULL;
   SWIG_TypeNewClientData(SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, SWIG_NewClientData(obj));
   return SWIG_Py_Void();
 }
 
-SWIGINTERN PyObject *vector_pvacuum_double_t_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vector_pvacuum_double_T_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   return SWIG_Python_InitShadowInstance(args);
 }
 
@@ -32833,558 +32833,558 @@ static PyMethodDef SwigMethods[] = {
 		"SwigPyIterator___sub__(SwigPyIterator self, SwigPyIterator x) -> ptrdiff_t\n"
 		""},
 	 { "SwigPyIterator_swigregister", SwigPyIterator_swigregister, METH_O, NULL},
-	 { "vdouble1d_t_iterator", _wrap_vdouble1d_t_iterator, METH_O, "vdouble1d_t_iterator(vdouble1d_t self) -> SwigPyIterator"},
-	 { "vdouble1d_t___nonzero__", _wrap_vdouble1d_t___nonzero__, METH_O, "vdouble1d_t___nonzero__(vdouble1d_t self) -> bool"},
-	 { "vdouble1d_t___bool__", _wrap_vdouble1d_t___bool__, METH_O, "vdouble1d_t___bool__(vdouble1d_t self) -> bool"},
-	 { "vdouble1d_t___len__", _wrap_vdouble1d_t___len__, METH_O, "vdouble1d_t___len__(vdouble1d_t self) -> std::vector< double >::size_type"},
-	 { "vdouble1d_t___getslice__", _wrap_vdouble1d_t___getslice__, METH_VARARGS, "vdouble1d_t___getslice__(vdouble1d_t self, std::vector< double >::difference_type i, std::vector< double >::difference_type j) -> vdouble1d_t"},
-	 { "vdouble1d_t___setslice__", _wrap_vdouble1d_t___setslice__, METH_VARARGS, "\n"
-		"vdouble1d_t___setslice__(vdouble1d_t self, std::vector< double >::difference_type i, std::vector< double >::difference_type j)\n"
-		"vdouble1d_t___setslice__(vdouble1d_t self, std::vector< double >::difference_type i, std::vector< double >::difference_type j, vdouble1d_t v)\n"
+	 { "vdouble1d_T_iterator", _wrap_vdouble1d_T_iterator, METH_O, "vdouble1d_T_iterator(vdouble1d_T self) -> SwigPyIterator"},
+	 { "vdouble1d_T___nonzero__", _wrap_vdouble1d_T___nonzero__, METH_O, "vdouble1d_T___nonzero__(vdouble1d_T self) -> bool"},
+	 { "vdouble1d_T___bool__", _wrap_vdouble1d_T___bool__, METH_O, "vdouble1d_T___bool__(vdouble1d_T self) -> bool"},
+	 { "vdouble1d_T___len__", _wrap_vdouble1d_T___len__, METH_O, "vdouble1d_T___len__(vdouble1d_T self) -> std::vector< double >::size_type"},
+	 { "vdouble1d_T___getslice__", _wrap_vdouble1d_T___getslice__, METH_VARARGS, "vdouble1d_T___getslice__(vdouble1d_T self, std::vector< double >::difference_type i, std::vector< double >::difference_type j) -> vdouble1d_T"},
+	 { "vdouble1d_T___setslice__", _wrap_vdouble1d_T___setslice__, METH_VARARGS, "\n"
+		"vdouble1d_T___setslice__(vdouble1d_T self, std::vector< double >::difference_type i, std::vector< double >::difference_type j)\n"
+		"vdouble1d_T___setslice__(vdouble1d_T self, std::vector< double >::difference_type i, std::vector< double >::difference_type j, vdouble1d_T v)\n"
 		""},
-	 { "vdouble1d_t___delslice__", _wrap_vdouble1d_t___delslice__, METH_VARARGS, "vdouble1d_t___delslice__(vdouble1d_t self, std::vector< double >::difference_type i, std::vector< double >::difference_type j)"},
-	 { "vdouble1d_t___delitem__", _wrap_vdouble1d_t___delitem__, METH_VARARGS, "\n"
-		"vdouble1d_t___delitem__(vdouble1d_t self, std::vector< double >::difference_type i)\n"
-		"vdouble1d_t___delitem__(vdouble1d_t self, SWIGPY_SLICEOBJECT * slice)\n"
+	 { "vdouble1d_T___delslice__", _wrap_vdouble1d_T___delslice__, METH_VARARGS, "vdouble1d_T___delslice__(vdouble1d_T self, std::vector< double >::difference_type i, std::vector< double >::difference_type j)"},
+	 { "vdouble1d_T___delitem__", _wrap_vdouble1d_T___delitem__, METH_VARARGS, "\n"
+		"vdouble1d_T___delitem__(vdouble1d_T self, std::vector< double >::difference_type i)\n"
+		"vdouble1d_T___delitem__(vdouble1d_T self, SWIGPY_SLICEOBJECT * slice)\n"
 		""},
-	 { "vdouble1d_t___getitem__", _wrap_vdouble1d_t___getitem__, METH_VARARGS, "\n"
-		"vdouble1d_t___getitem__(vdouble1d_t self, SWIGPY_SLICEOBJECT * slice) -> vdouble1d_t\n"
-		"vdouble1d_t___getitem__(vdouble1d_t self, std::vector< double >::difference_type i) -> std::vector< double >::value_type const &\n"
+	 { "vdouble1d_T___getitem__", _wrap_vdouble1d_T___getitem__, METH_VARARGS, "\n"
+		"vdouble1d_T___getitem__(vdouble1d_T self, SWIGPY_SLICEOBJECT * slice) -> vdouble1d_T\n"
+		"vdouble1d_T___getitem__(vdouble1d_T self, std::vector< double >::difference_type i) -> std::vector< double >::value_type const &\n"
 		""},
-	 { "vdouble1d_t___setitem__", _wrap_vdouble1d_t___setitem__, METH_VARARGS, "\n"
-		"vdouble1d_t___setitem__(vdouble1d_t self, SWIGPY_SLICEOBJECT * slice, vdouble1d_t v)\n"
-		"vdouble1d_t___setitem__(vdouble1d_t self, SWIGPY_SLICEOBJECT * slice)\n"
-		"vdouble1d_t___setitem__(vdouble1d_t self, std::vector< double >::difference_type i, std::vector< double >::value_type const & x)\n"
+	 { "vdouble1d_T___setitem__", _wrap_vdouble1d_T___setitem__, METH_VARARGS, "\n"
+		"vdouble1d_T___setitem__(vdouble1d_T self, SWIGPY_SLICEOBJECT * slice, vdouble1d_T v)\n"
+		"vdouble1d_T___setitem__(vdouble1d_T self, SWIGPY_SLICEOBJECT * slice)\n"
+		"vdouble1d_T___setitem__(vdouble1d_T self, std::vector< double >::difference_type i, std::vector< double >::value_type const & x)\n"
 		""},
-	 { "vdouble1d_t_pop", _wrap_vdouble1d_t_pop, METH_O, "vdouble1d_t_pop(vdouble1d_t self) -> std::vector< double >::value_type"},
-	 { "vdouble1d_t_append", _wrap_vdouble1d_t_append, METH_VARARGS, "vdouble1d_t_append(vdouble1d_t self, std::vector< double >::value_type const & x)"},
-	 { "vdouble1d_t_empty", _wrap_vdouble1d_t_empty, METH_O, "vdouble1d_t_empty(vdouble1d_t self) -> bool"},
-	 { "vdouble1d_t_size", _wrap_vdouble1d_t_size, METH_O, "vdouble1d_t_size(vdouble1d_t self) -> std::vector< double >::size_type"},
-	 { "vdouble1d_t_swap", _wrap_vdouble1d_t_swap, METH_VARARGS, "vdouble1d_t_swap(vdouble1d_t self, vdouble1d_t v)"},
-	 { "vdouble1d_t_begin", _wrap_vdouble1d_t_begin, METH_O, "vdouble1d_t_begin(vdouble1d_t self) -> std::vector< double >::iterator"},
-	 { "vdouble1d_t_end", _wrap_vdouble1d_t_end, METH_O, "vdouble1d_t_end(vdouble1d_t self) -> std::vector< double >::iterator"},
-	 { "vdouble1d_t_rbegin", _wrap_vdouble1d_t_rbegin, METH_O, "vdouble1d_t_rbegin(vdouble1d_t self) -> std::vector< double >::reverse_iterator"},
-	 { "vdouble1d_t_rend", _wrap_vdouble1d_t_rend, METH_O, "vdouble1d_t_rend(vdouble1d_t self) -> std::vector< double >::reverse_iterator"},
-	 { "vdouble1d_t_clear", _wrap_vdouble1d_t_clear, METH_O, "vdouble1d_t_clear(vdouble1d_t self)"},
-	 { "vdouble1d_t_get_allocator", _wrap_vdouble1d_t_get_allocator, METH_O, "vdouble1d_t_get_allocator(vdouble1d_t self) -> std::vector< double >::allocator_type"},
-	 { "vdouble1d_t_pop_back", _wrap_vdouble1d_t_pop_back, METH_O, "vdouble1d_t_pop_back(vdouble1d_t self)"},
-	 { "vdouble1d_t_erase", _wrap_vdouble1d_t_erase, METH_VARARGS, "\n"
-		"vdouble1d_t_erase(vdouble1d_t self, std::vector< double >::iterator pos) -> std::vector< double >::iterator\n"
-		"vdouble1d_t_erase(vdouble1d_t self, std::vector< double >::iterator first, std::vector< double >::iterator last) -> std::vector< double >::iterator\n"
+	 { "vdouble1d_T_pop", _wrap_vdouble1d_T_pop, METH_O, "vdouble1d_T_pop(vdouble1d_T self) -> std::vector< double >::value_type"},
+	 { "vdouble1d_T_append", _wrap_vdouble1d_T_append, METH_VARARGS, "vdouble1d_T_append(vdouble1d_T self, std::vector< double >::value_type const & x)"},
+	 { "vdouble1d_T_empty", _wrap_vdouble1d_T_empty, METH_O, "vdouble1d_T_empty(vdouble1d_T self) -> bool"},
+	 { "vdouble1d_T_size", _wrap_vdouble1d_T_size, METH_O, "vdouble1d_T_size(vdouble1d_T self) -> std::vector< double >::size_type"},
+	 { "vdouble1d_T_swap", _wrap_vdouble1d_T_swap, METH_VARARGS, "vdouble1d_T_swap(vdouble1d_T self, vdouble1d_T v)"},
+	 { "vdouble1d_T_begin", _wrap_vdouble1d_T_begin, METH_O, "vdouble1d_T_begin(vdouble1d_T self) -> std::vector< double >::iterator"},
+	 { "vdouble1d_T_end", _wrap_vdouble1d_T_end, METH_O, "vdouble1d_T_end(vdouble1d_T self) -> std::vector< double >::iterator"},
+	 { "vdouble1d_T_rbegin", _wrap_vdouble1d_T_rbegin, METH_O, "vdouble1d_T_rbegin(vdouble1d_T self) -> std::vector< double >::reverse_iterator"},
+	 { "vdouble1d_T_rend", _wrap_vdouble1d_T_rend, METH_O, "vdouble1d_T_rend(vdouble1d_T self) -> std::vector< double >::reverse_iterator"},
+	 { "vdouble1d_T_clear", _wrap_vdouble1d_T_clear, METH_O, "vdouble1d_T_clear(vdouble1d_T self)"},
+	 { "vdouble1d_T_get_allocator", _wrap_vdouble1d_T_get_allocator, METH_O, "vdouble1d_T_get_allocator(vdouble1d_T self) -> std::vector< double >::allocator_type"},
+	 { "vdouble1d_T_pop_back", _wrap_vdouble1d_T_pop_back, METH_O, "vdouble1d_T_pop_back(vdouble1d_T self)"},
+	 { "vdouble1d_T_erase", _wrap_vdouble1d_T_erase, METH_VARARGS, "\n"
+		"vdouble1d_T_erase(vdouble1d_T self, std::vector< double >::iterator pos) -> std::vector< double >::iterator\n"
+		"vdouble1d_T_erase(vdouble1d_T self, std::vector< double >::iterator first, std::vector< double >::iterator last) -> std::vector< double >::iterator\n"
 		""},
-	 { "new_vdouble1d_t", _wrap_new_vdouble1d_t, METH_VARARGS, "\n"
-		"vdouble1d_t()\n"
-		"vdouble1d_t(vdouble1d_t other)\n"
-		"vdouble1d_t(std::vector< double >::size_type size)\n"
-		"new_vdouble1d_t(std::vector< double >::size_type size, std::vector< double >::value_type const & value) -> vdouble1d_t\n"
+	 { "new_vdouble1d_T", _wrap_new_vdouble1d_T, METH_VARARGS, "\n"
+		"vdouble1d_T()\n"
+		"vdouble1d_T(vdouble1d_T other)\n"
+		"vdouble1d_T(std::vector< double >::size_type size)\n"
+		"new_vdouble1d_T(std::vector< double >::size_type size, std::vector< double >::value_type const & value) -> vdouble1d_T\n"
 		""},
-	 { "vdouble1d_t_push_back", _wrap_vdouble1d_t_push_back, METH_VARARGS, "vdouble1d_t_push_back(vdouble1d_t self, std::vector< double >::value_type const & x)"},
-	 { "vdouble1d_t_front", _wrap_vdouble1d_t_front, METH_O, "vdouble1d_t_front(vdouble1d_t self) -> std::vector< double >::value_type const &"},
-	 { "vdouble1d_t_back", _wrap_vdouble1d_t_back, METH_O, "vdouble1d_t_back(vdouble1d_t self) -> std::vector< double >::value_type const &"},
-	 { "vdouble1d_t_assign", _wrap_vdouble1d_t_assign, METH_VARARGS, "vdouble1d_t_assign(vdouble1d_t self, std::vector< double >::size_type n, std::vector< double >::value_type const & x)"},
-	 { "vdouble1d_t_resize", _wrap_vdouble1d_t_resize, METH_VARARGS, "\n"
-		"vdouble1d_t_resize(vdouble1d_t self, std::vector< double >::size_type new_size)\n"
-		"vdouble1d_t_resize(vdouble1d_t self, std::vector< double >::size_type new_size, std::vector< double >::value_type const & x)\n"
+	 { "vdouble1d_T_push_back", _wrap_vdouble1d_T_push_back, METH_VARARGS, "vdouble1d_T_push_back(vdouble1d_T self, std::vector< double >::value_type const & x)"},
+	 { "vdouble1d_T_front", _wrap_vdouble1d_T_front, METH_O, "vdouble1d_T_front(vdouble1d_T self) -> std::vector< double >::value_type const &"},
+	 { "vdouble1d_T_back", _wrap_vdouble1d_T_back, METH_O, "vdouble1d_T_back(vdouble1d_T self) -> std::vector< double >::value_type const &"},
+	 { "vdouble1d_T_assign", _wrap_vdouble1d_T_assign, METH_VARARGS, "vdouble1d_T_assign(vdouble1d_T self, std::vector< double >::size_type n, std::vector< double >::value_type const & x)"},
+	 { "vdouble1d_T_resize", _wrap_vdouble1d_T_resize, METH_VARARGS, "\n"
+		"vdouble1d_T_resize(vdouble1d_T self, std::vector< double >::size_type new_size)\n"
+		"vdouble1d_T_resize(vdouble1d_T self, std::vector< double >::size_type new_size, std::vector< double >::value_type const & x)\n"
 		""},
-	 { "vdouble1d_t_insert", _wrap_vdouble1d_t_insert, METH_VARARGS, "\n"
-		"vdouble1d_t_insert(vdouble1d_t self, std::vector< double >::iterator pos, std::vector< double >::value_type const & x) -> std::vector< double >::iterator\n"
-		"vdouble1d_t_insert(vdouble1d_t self, std::vector< double >::iterator pos, std::vector< double >::size_type n, std::vector< double >::value_type const & x)\n"
+	 { "vdouble1d_T_insert", _wrap_vdouble1d_T_insert, METH_VARARGS, "\n"
+		"vdouble1d_T_insert(vdouble1d_T self, std::vector< double >::iterator pos, std::vector< double >::value_type const & x) -> std::vector< double >::iterator\n"
+		"vdouble1d_T_insert(vdouble1d_T self, std::vector< double >::iterator pos, std::vector< double >::size_type n, std::vector< double >::value_type const & x)\n"
 		""},
-	 { "vdouble1d_t_reserve", _wrap_vdouble1d_t_reserve, METH_VARARGS, "vdouble1d_t_reserve(vdouble1d_t self, std::vector< double >::size_type n)"},
-	 { "vdouble1d_t_capacity", _wrap_vdouble1d_t_capacity, METH_O, "vdouble1d_t_capacity(vdouble1d_t self) -> std::vector< double >::size_type"},
-	 { "delete_vdouble1d_t", _wrap_delete_vdouble1d_t, METH_O, "delete_vdouble1d_t(vdouble1d_t self)"},
-	 { "vdouble1d_t_swigregister", vdouble1d_t_swigregister, METH_O, NULL},
-	 { "vdouble1d_t_swiginit", vdouble1d_t_swiginit, METH_VARARGS, NULL},
-	 { "vdouble2d_t_iterator", _wrap_vdouble2d_t_iterator, METH_O, "vdouble2d_t_iterator(vdouble2d_t self) -> SwigPyIterator"},
-	 { "vdouble2d_t___nonzero__", _wrap_vdouble2d_t___nonzero__, METH_O, "vdouble2d_t___nonzero__(vdouble2d_t self) -> bool"},
-	 { "vdouble2d_t___bool__", _wrap_vdouble2d_t___bool__, METH_O, "vdouble2d_t___bool__(vdouble2d_t self) -> bool"},
-	 { "vdouble2d_t___len__", _wrap_vdouble2d_t___len__, METH_O, "vdouble2d_t___len__(vdouble2d_t self) -> std::vector< std::vector< double > >::size_type"},
-	 { "vdouble2d_t___getslice__", _wrap_vdouble2d_t___getslice__, METH_VARARGS, "vdouble2d_t___getslice__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j) -> vdouble2d_t"},
-	 { "vdouble2d_t___setslice__", _wrap_vdouble2d_t___setslice__, METH_VARARGS, "\n"
-		"vdouble2d_t___setslice__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j)\n"
-		"vdouble2d_t___setslice__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j, vdouble2d_t v)\n"
+	 { "vdouble1d_T_reserve", _wrap_vdouble1d_T_reserve, METH_VARARGS, "vdouble1d_T_reserve(vdouble1d_T self, std::vector< double >::size_type n)"},
+	 { "vdouble1d_T_capacity", _wrap_vdouble1d_T_capacity, METH_O, "vdouble1d_T_capacity(vdouble1d_T self) -> std::vector< double >::size_type"},
+	 { "delete_vdouble1d_T", _wrap_delete_vdouble1d_T, METH_O, "delete_vdouble1d_T(vdouble1d_T self)"},
+	 { "vdouble1d_T_swigregister", vdouble1d_T_swigregister, METH_O, NULL},
+	 { "vdouble1d_T_swiginit", vdouble1d_T_swiginit, METH_VARARGS, NULL},
+	 { "vdouble2d_T_iterator", _wrap_vdouble2d_T_iterator, METH_O, "vdouble2d_T_iterator(vdouble2d_T self) -> SwigPyIterator"},
+	 { "vdouble2d_T___nonzero__", _wrap_vdouble2d_T___nonzero__, METH_O, "vdouble2d_T___nonzero__(vdouble2d_T self) -> bool"},
+	 { "vdouble2d_T___bool__", _wrap_vdouble2d_T___bool__, METH_O, "vdouble2d_T___bool__(vdouble2d_T self) -> bool"},
+	 { "vdouble2d_T___len__", _wrap_vdouble2d_T___len__, METH_O, "vdouble2d_T___len__(vdouble2d_T self) -> std::vector< std::vector< double > >::size_type"},
+	 { "vdouble2d_T___getslice__", _wrap_vdouble2d_T___getslice__, METH_VARARGS, "vdouble2d_T___getslice__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j) -> vdouble2d_T"},
+	 { "vdouble2d_T___setslice__", _wrap_vdouble2d_T___setslice__, METH_VARARGS, "\n"
+		"vdouble2d_T___setslice__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j)\n"
+		"vdouble2d_T___setslice__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j, vdouble2d_T v)\n"
 		""},
-	 { "vdouble2d_t___delslice__", _wrap_vdouble2d_t___delslice__, METH_VARARGS, "vdouble2d_t___delslice__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j)"},
-	 { "vdouble2d_t___delitem__", _wrap_vdouble2d_t___delitem__, METH_VARARGS, "\n"
-		"vdouble2d_t___delitem__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i)\n"
-		"vdouble2d_t___delitem__(vdouble2d_t self, SWIGPY_SLICEOBJECT * slice)\n"
+	 { "vdouble2d_T___delslice__", _wrap_vdouble2d_T___delslice__, METH_VARARGS, "vdouble2d_T___delslice__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j)"},
+	 { "vdouble2d_T___delitem__", _wrap_vdouble2d_T___delitem__, METH_VARARGS, "\n"
+		"vdouble2d_T___delitem__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i)\n"
+		"vdouble2d_T___delitem__(vdouble2d_T self, SWIGPY_SLICEOBJECT * slice)\n"
 		""},
-	 { "vdouble2d_t___getitem__", _wrap_vdouble2d_t___getitem__, METH_VARARGS, "\n"
-		"vdouble2d_t___getitem__(vdouble2d_t self, SWIGPY_SLICEOBJECT * slice) -> vdouble2d_t\n"
-		"vdouble2d_t___getitem__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i) -> vdouble1d_t\n"
+	 { "vdouble2d_T___getitem__", _wrap_vdouble2d_T___getitem__, METH_VARARGS, "\n"
+		"vdouble2d_T___getitem__(vdouble2d_T self, SWIGPY_SLICEOBJECT * slice) -> vdouble2d_T\n"
+		"vdouble2d_T___getitem__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i) -> vdouble1d_T\n"
 		""},
-	 { "vdouble2d_t___setitem__", _wrap_vdouble2d_t___setitem__, METH_VARARGS, "\n"
-		"vdouble2d_t___setitem__(vdouble2d_t self, SWIGPY_SLICEOBJECT * slice, vdouble2d_t v)\n"
-		"vdouble2d_t___setitem__(vdouble2d_t self, SWIGPY_SLICEOBJECT * slice)\n"
-		"vdouble2d_t___setitem__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i, vdouble1d_t x)\n"
+	 { "vdouble2d_T___setitem__", _wrap_vdouble2d_T___setitem__, METH_VARARGS, "\n"
+		"vdouble2d_T___setitem__(vdouble2d_T self, SWIGPY_SLICEOBJECT * slice, vdouble2d_T v)\n"
+		"vdouble2d_T___setitem__(vdouble2d_T self, SWIGPY_SLICEOBJECT * slice)\n"
+		"vdouble2d_T___setitem__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i, vdouble1d_T x)\n"
 		""},
-	 { "vdouble2d_t_pop", _wrap_vdouble2d_t_pop, METH_O, "vdouble2d_t_pop(vdouble2d_t self) -> vdouble1d_t"},
-	 { "vdouble2d_t_append", _wrap_vdouble2d_t_append, METH_VARARGS, "vdouble2d_t_append(vdouble2d_t self, vdouble1d_t x)"},
-	 { "vdouble2d_t_empty", _wrap_vdouble2d_t_empty, METH_O, "vdouble2d_t_empty(vdouble2d_t self) -> bool"},
-	 { "vdouble2d_t_size", _wrap_vdouble2d_t_size, METH_O, "vdouble2d_t_size(vdouble2d_t self) -> std::vector< std::vector< double > >::size_type"},
-	 { "vdouble2d_t_swap", _wrap_vdouble2d_t_swap, METH_VARARGS, "vdouble2d_t_swap(vdouble2d_t self, vdouble2d_t v)"},
-	 { "vdouble2d_t_begin", _wrap_vdouble2d_t_begin, METH_O, "vdouble2d_t_begin(vdouble2d_t self) -> std::vector< std::vector< double > >::iterator"},
-	 { "vdouble2d_t_end", _wrap_vdouble2d_t_end, METH_O, "vdouble2d_t_end(vdouble2d_t self) -> std::vector< std::vector< double > >::iterator"},
-	 { "vdouble2d_t_rbegin", _wrap_vdouble2d_t_rbegin, METH_O, "vdouble2d_t_rbegin(vdouble2d_t self) -> std::vector< std::vector< double > >::reverse_iterator"},
-	 { "vdouble2d_t_rend", _wrap_vdouble2d_t_rend, METH_O, "vdouble2d_t_rend(vdouble2d_t self) -> std::vector< std::vector< double > >::reverse_iterator"},
-	 { "vdouble2d_t_clear", _wrap_vdouble2d_t_clear, METH_O, "vdouble2d_t_clear(vdouble2d_t self)"},
-	 { "vdouble2d_t_get_allocator", _wrap_vdouble2d_t_get_allocator, METH_O, "vdouble2d_t_get_allocator(vdouble2d_t self) -> std::vector< std::vector< double > >::allocator_type"},
-	 { "vdouble2d_t_pop_back", _wrap_vdouble2d_t_pop_back, METH_O, "vdouble2d_t_pop_back(vdouble2d_t self)"},
-	 { "vdouble2d_t_erase", _wrap_vdouble2d_t_erase, METH_VARARGS, "\n"
-		"vdouble2d_t_erase(vdouble2d_t self, std::vector< std::vector< double > >::iterator pos) -> std::vector< std::vector< double > >::iterator\n"
-		"vdouble2d_t_erase(vdouble2d_t self, std::vector< std::vector< double > >::iterator first, std::vector< std::vector< double > >::iterator last) -> std::vector< std::vector< double > >::iterator\n"
+	 { "vdouble2d_T_pop", _wrap_vdouble2d_T_pop, METH_O, "vdouble2d_T_pop(vdouble2d_T self) -> vdouble1d_T"},
+	 { "vdouble2d_T_append", _wrap_vdouble2d_T_append, METH_VARARGS, "vdouble2d_T_append(vdouble2d_T self, vdouble1d_T x)"},
+	 { "vdouble2d_T_empty", _wrap_vdouble2d_T_empty, METH_O, "vdouble2d_T_empty(vdouble2d_T self) -> bool"},
+	 { "vdouble2d_T_size", _wrap_vdouble2d_T_size, METH_O, "vdouble2d_T_size(vdouble2d_T self) -> std::vector< std::vector< double > >::size_type"},
+	 { "vdouble2d_T_swap", _wrap_vdouble2d_T_swap, METH_VARARGS, "vdouble2d_T_swap(vdouble2d_T self, vdouble2d_T v)"},
+	 { "vdouble2d_T_begin", _wrap_vdouble2d_T_begin, METH_O, "vdouble2d_T_begin(vdouble2d_T self) -> std::vector< std::vector< double > >::iterator"},
+	 { "vdouble2d_T_end", _wrap_vdouble2d_T_end, METH_O, "vdouble2d_T_end(vdouble2d_T self) -> std::vector< std::vector< double > >::iterator"},
+	 { "vdouble2d_T_rbegin", _wrap_vdouble2d_T_rbegin, METH_O, "vdouble2d_T_rbegin(vdouble2d_T self) -> std::vector< std::vector< double > >::reverse_iterator"},
+	 { "vdouble2d_T_rend", _wrap_vdouble2d_T_rend, METH_O, "vdouble2d_T_rend(vdouble2d_T self) -> std::vector< std::vector< double > >::reverse_iterator"},
+	 { "vdouble2d_T_clear", _wrap_vdouble2d_T_clear, METH_O, "vdouble2d_T_clear(vdouble2d_T self)"},
+	 { "vdouble2d_T_get_allocator", _wrap_vdouble2d_T_get_allocator, METH_O, "vdouble2d_T_get_allocator(vdouble2d_T self) -> std::vector< std::vector< double > >::allocator_type"},
+	 { "vdouble2d_T_pop_back", _wrap_vdouble2d_T_pop_back, METH_O, "vdouble2d_T_pop_back(vdouble2d_T self)"},
+	 { "vdouble2d_T_erase", _wrap_vdouble2d_T_erase, METH_VARARGS, "\n"
+		"vdouble2d_T_erase(vdouble2d_T self, std::vector< std::vector< double > >::iterator pos) -> std::vector< std::vector< double > >::iterator\n"
+		"vdouble2d_T_erase(vdouble2d_T self, std::vector< std::vector< double > >::iterator first, std::vector< std::vector< double > >::iterator last) -> std::vector< std::vector< double > >::iterator\n"
 		""},
-	 { "new_vdouble2d_t", _wrap_new_vdouble2d_t, METH_VARARGS, "\n"
-		"vdouble2d_t()\n"
-		"vdouble2d_t(vdouble2d_t other)\n"
-		"vdouble2d_t(std::vector< std::vector< double > >::size_type size)\n"
-		"new_vdouble2d_t(std::vector< std::vector< double > >::size_type size, vdouble1d_t value) -> vdouble2d_t\n"
+	 { "new_vdouble2d_T", _wrap_new_vdouble2d_T, METH_VARARGS, "\n"
+		"vdouble2d_T()\n"
+		"vdouble2d_T(vdouble2d_T other)\n"
+		"vdouble2d_T(std::vector< std::vector< double > >::size_type size)\n"
+		"new_vdouble2d_T(std::vector< std::vector< double > >::size_type size, vdouble1d_T value) -> vdouble2d_T\n"
 		""},
-	 { "vdouble2d_t_push_back", _wrap_vdouble2d_t_push_back, METH_VARARGS, "vdouble2d_t_push_back(vdouble2d_t self, vdouble1d_t x)"},
-	 { "vdouble2d_t_front", _wrap_vdouble2d_t_front, METH_O, "vdouble2d_t_front(vdouble2d_t self) -> vdouble1d_t"},
-	 { "vdouble2d_t_back", _wrap_vdouble2d_t_back, METH_O, "vdouble2d_t_back(vdouble2d_t self) -> vdouble1d_t"},
-	 { "vdouble2d_t_assign", _wrap_vdouble2d_t_assign, METH_VARARGS, "vdouble2d_t_assign(vdouble2d_t self, std::vector< std::vector< double > >::size_type n, vdouble1d_t x)"},
-	 { "vdouble2d_t_resize", _wrap_vdouble2d_t_resize, METH_VARARGS, "\n"
-		"vdouble2d_t_resize(vdouble2d_t self, std::vector< std::vector< double > >::size_type new_size)\n"
-		"vdouble2d_t_resize(vdouble2d_t self, std::vector< std::vector< double > >::size_type new_size, vdouble1d_t x)\n"
+	 { "vdouble2d_T_push_back", _wrap_vdouble2d_T_push_back, METH_VARARGS, "vdouble2d_T_push_back(vdouble2d_T self, vdouble1d_T x)"},
+	 { "vdouble2d_T_front", _wrap_vdouble2d_T_front, METH_O, "vdouble2d_T_front(vdouble2d_T self) -> vdouble1d_T"},
+	 { "vdouble2d_T_back", _wrap_vdouble2d_T_back, METH_O, "vdouble2d_T_back(vdouble2d_T self) -> vdouble1d_T"},
+	 { "vdouble2d_T_assign", _wrap_vdouble2d_T_assign, METH_VARARGS, "vdouble2d_T_assign(vdouble2d_T self, std::vector< std::vector< double > >::size_type n, vdouble1d_T x)"},
+	 { "vdouble2d_T_resize", _wrap_vdouble2d_T_resize, METH_VARARGS, "\n"
+		"vdouble2d_T_resize(vdouble2d_T self, std::vector< std::vector< double > >::size_type new_size)\n"
+		"vdouble2d_T_resize(vdouble2d_T self, std::vector< std::vector< double > >::size_type new_size, vdouble1d_T x)\n"
 		""},
-	 { "vdouble2d_t_insert", _wrap_vdouble2d_t_insert, METH_VARARGS, "\n"
-		"vdouble2d_t_insert(vdouble2d_t self, std::vector< std::vector< double > >::iterator pos, vdouble1d_t x) -> std::vector< std::vector< double > >::iterator\n"
-		"vdouble2d_t_insert(vdouble2d_t self, std::vector< std::vector< double > >::iterator pos, std::vector< std::vector< double > >::size_type n, vdouble1d_t x)\n"
+	 { "vdouble2d_T_insert", _wrap_vdouble2d_T_insert, METH_VARARGS, "\n"
+		"vdouble2d_T_insert(vdouble2d_T self, std::vector< std::vector< double > >::iterator pos, vdouble1d_T x) -> std::vector< std::vector< double > >::iterator\n"
+		"vdouble2d_T_insert(vdouble2d_T self, std::vector< std::vector< double > >::iterator pos, std::vector< std::vector< double > >::size_type n, vdouble1d_T x)\n"
 		""},
-	 { "vdouble2d_t_reserve", _wrap_vdouble2d_t_reserve, METH_VARARGS, "vdouble2d_t_reserve(vdouble2d_t self, std::vector< std::vector< double > >::size_type n)"},
-	 { "vdouble2d_t_capacity", _wrap_vdouble2d_t_capacity, METH_O, "vdouble2d_t_capacity(vdouble2d_t self) -> std::vector< std::vector< double > >::size_type"},
-	 { "delete_vdouble2d_t", _wrap_delete_vdouble2d_t, METH_O, "delete_vdouble2d_t(vdouble2d_t self)"},
-	 { "vdouble2d_t_swigregister", vdouble2d_t_swigregister, METH_O, NULL},
-	 { "vdouble2d_t_swiginit", vdouble2d_t_swiginit, METH_VARARGS, NULL},
-	 { "vector_integer_t_iterator", _wrap_vector_integer_t_iterator, METH_O, "vector_integer_t_iterator(vector_integer_t self) -> SwigPyIterator"},
-	 { "vector_integer_t___nonzero__", _wrap_vector_integer_t___nonzero__, METH_O, "vector_integer_t___nonzero__(vector_integer_t self) -> bool"},
-	 { "vector_integer_t___bool__", _wrap_vector_integer_t___bool__, METH_O, "vector_integer_t___bool__(vector_integer_t self) -> bool"},
-	 { "vector_integer_t___len__", _wrap_vector_integer_t___len__, METH_O, "vector_integer_t___len__(vector_integer_t self) -> std::vector< int >::size_type"},
-	 { "vector_integer_t___getslice__", _wrap_vector_integer_t___getslice__, METH_VARARGS, "vector_integer_t___getslice__(vector_integer_t self, std::vector< int >::difference_type i, std::vector< int >::difference_type j) -> vector_integer_t"},
-	 { "vector_integer_t___setslice__", _wrap_vector_integer_t___setslice__, METH_VARARGS, "\n"
-		"vector_integer_t___setslice__(vector_integer_t self, std::vector< int >::difference_type i, std::vector< int >::difference_type j)\n"
-		"vector_integer_t___setslice__(vector_integer_t self, std::vector< int >::difference_type i, std::vector< int >::difference_type j, vector_integer_t v)\n"
+	 { "vdouble2d_T_reserve", _wrap_vdouble2d_T_reserve, METH_VARARGS, "vdouble2d_T_reserve(vdouble2d_T self, std::vector< std::vector< double > >::size_type n)"},
+	 { "vdouble2d_T_capacity", _wrap_vdouble2d_T_capacity, METH_O, "vdouble2d_T_capacity(vdouble2d_T self) -> std::vector< std::vector< double > >::size_type"},
+	 { "delete_vdouble2d_T", _wrap_delete_vdouble2d_T, METH_O, "delete_vdouble2d_T(vdouble2d_T self)"},
+	 { "vdouble2d_T_swigregister", vdouble2d_T_swigregister, METH_O, NULL},
+	 { "vdouble2d_T_swiginit", vdouble2d_T_swiginit, METH_VARARGS, NULL},
+	 { "vector_integer_T_iterator", _wrap_vector_integer_T_iterator, METH_O, "vector_integer_T_iterator(vector_integer_T self) -> SwigPyIterator"},
+	 { "vector_integer_T___nonzero__", _wrap_vector_integer_T___nonzero__, METH_O, "vector_integer_T___nonzero__(vector_integer_T self) -> bool"},
+	 { "vector_integer_T___bool__", _wrap_vector_integer_T___bool__, METH_O, "vector_integer_T___bool__(vector_integer_T self) -> bool"},
+	 { "vector_integer_T___len__", _wrap_vector_integer_T___len__, METH_O, "vector_integer_T___len__(vector_integer_T self) -> std::vector< int >::size_type"},
+	 { "vector_integer_T___getslice__", _wrap_vector_integer_T___getslice__, METH_VARARGS, "vector_integer_T___getslice__(vector_integer_T self, std::vector< int >::difference_type i, std::vector< int >::difference_type j) -> vector_integer_T"},
+	 { "vector_integer_T___setslice__", _wrap_vector_integer_T___setslice__, METH_VARARGS, "\n"
+		"vector_integer_T___setslice__(vector_integer_T self, std::vector< int >::difference_type i, std::vector< int >::difference_type j)\n"
+		"vector_integer_T___setslice__(vector_integer_T self, std::vector< int >::difference_type i, std::vector< int >::difference_type j, vector_integer_T v)\n"
 		""},
-	 { "vector_integer_t___delslice__", _wrap_vector_integer_t___delslice__, METH_VARARGS, "vector_integer_t___delslice__(vector_integer_t self, std::vector< int >::difference_type i, std::vector< int >::difference_type j)"},
-	 { "vector_integer_t___delitem__", _wrap_vector_integer_t___delitem__, METH_VARARGS, "\n"
-		"vector_integer_t___delitem__(vector_integer_t self, std::vector< int >::difference_type i)\n"
-		"vector_integer_t___delitem__(vector_integer_t self, SWIGPY_SLICEOBJECT * slice)\n"
+	 { "vector_integer_T___delslice__", _wrap_vector_integer_T___delslice__, METH_VARARGS, "vector_integer_T___delslice__(vector_integer_T self, std::vector< int >::difference_type i, std::vector< int >::difference_type j)"},
+	 { "vector_integer_T___delitem__", _wrap_vector_integer_T___delitem__, METH_VARARGS, "\n"
+		"vector_integer_T___delitem__(vector_integer_T self, std::vector< int >::difference_type i)\n"
+		"vector_integer_T___delitem__(vector_integer_T self, SWIGPY_SLICEOBJECT * slice)\n"
 		""},
-	 { "vector_integer_t___getitem__", _wrap_vector_integer_t___getitem__, METH_VARARGS, "\n"
-		"vector_integer_t___getitem__(vector_integer_t self, SWIGPY_SLICEOBJECT * slice) -> vector_integer_t\n"
-		"vector_integer_t___getitem__(vector_integer_t self, std::vector< int >::difference_type i) -> std::vector< int >::value_type const &\n"
+	 { "vector_integer_T___getitem__", _wrap_vector_integer_T___getitem__, METH_VARARGS, "\n"
+		"vector_integer_T___getitem__(vector_integer_T self, SWIGPY_SLICEOBJECT * slice) -> vector_integer_T\n"
+		"vector_integer_T___getitem__(vector_integer_T self, std::vector< int >::difference_type i) -> std::vector< int >::value_type const &\n"
 		""},
-	 { "vector_integer_t___setitem__", _wrap_vector_integer_t___setitem__, METH_VARARGS, "\n"
-		"vector_integer_t___setitem__(vector_integer_t self, SWIGPY_SLICEOBJECT * slice, vector_integer_t v)\n"
-		"vector_integer_t___setitem__(vector_integer_t self, SWIGPY_SLICEOBJECT * slice)\n"
-		"vector_integer_t___setitem__(vector_integer_t self, std::vector< int >::difference_type i, std::vector< int >::value_type const & x)\n"
+	 { "vector_integer_T___setitem__", _wrap_vector_integer_T___setitem__, METH_VARARGS, "\n"
+		"vector_integer_T___setitem__(vector_integer_T self, SWIGPY_SLICEOBJECT * slice, vector_integer_T v)\n"
+		"vector_integer_T___setitem__(vector_integer_T self, SWIGPY_SLICEOBJECT * slice)\n"
+		"vector_integer_T___setitem__(vector_integer_T self, std::vector< int >::difference_type i, std::vector< int >::value_type const & x)\n"
 		""},
-	 { "vector_integer_t_pop", _wrap_vector_integer_t_pop, METH_O, "vector_integer_t_pop(vector_integer_t self) -> std::vector< int >::value_type"},
-	 { "vector_integer_t_append", _wrap_vector_integer_t_append, METH_VARARGS, "vector_integer_t_append(vector_integer_t self, std::vector< int >::value_type const & x)"},
-	 { "vector_integer_t_empty", _wrap_vector_integer_t_empty, METH_O, "vector_integer_t_empty(vector_integer_t self) -> bool"},
-	 { "vector_integer_t_size", _wrap_vector_integer_t_size, METH_O, "vector_integer_t_size(vector_integer_t self) -> std::vector< int >::size_type"},
-	 { "vector_integer_t_swap", _wrap_vector_integer_t_swap, METH_VARARGS, "vector_integer_t_swap(vector_integer_t self, vector_integer_t v)"},
-	 { "vector_integer_t_begin", _wrap_vector_integer_t_begin, METH_O, "vector_integer_t_begin(vector_integer_t self) -> std::vector< int >::iterator"},
-	 { "vector_integer_t_end", _wrap_vector_integer_t_end, METH_O, "vector_integer_t_end(vector_integer_t self) -> std::vector< int >::iterator"},
-	 { "vector_integer_t_rbegin", _wrap_vector_integer_t_rbegin, METH_O, "vector_integer_t_rbegin(vector_integer_t self) -> std::vector< int >::reverse_iterator"},
-	 { "vector_integer_t_rend", _wrap_vector_integer_t_rend, METH_O, "vector_integer_t_rend(vector_integer_t self) -> std::vector< int >::reverse_iterator"},
-	 { "vector_integer_t_clear", _wrap_vector_integer_t_clear, METH_O, "vector_integer_t_clear(vector_integer_t self)"},
-	 { "vector_integer_t_get_allocator", _wrap_vector_integer_t_get_allocator, METH_O, "vector_integer_t_get_allocator(vector_integer_t self) -> std::vector< int >::allocator_type"},
-	 { "vector_integer_t_pop_back", _wrap_vector_integer_t_pop_back, METH_O, "vector_integer_t_pop_back(vector_integer_t self)"},
-	 { "vector_integer_t_erase", _wrap_vector_integer_t_erase, METH_VARARGS, "\n"
-		"vector_integer_t_erase(vector_integer_t self, std::vector< int >::iterator pos) -> std::vector< int >::iterator\n"
-		"vector_integer_t_erase(vector_integer_t self, std::vector< int >::iterator first, std::vector< int >::iterator last) -> std::vector< int >::iterator\n"
+	 { "vector_integer_T_pop", _wrap_vector_integer_T_pop, METH_O, "vector_integer_T_pop(vector_integer_T self) -> std::vector< int >::value_type"},
+	 { "vector_integer_T_append", _wrap_vector_integer_T_append, METH_VARARGS, "vector_integer_T_append(vector_integer_T self, std::vector< int >::value_type const & x)"},
+	 { "vector_integer_T_empty", _wrap_vector_integer_T_empty, METH_O, "vector_integer_T_empty(vector_integer_T self) -> bool"},
+	 { "vector_integer_T_size", _wrap_vector_integer_T_size, METH_O, "vector_integer_T_size(vector_integer_T self) -> std::vector< int >::size_type"},
+	 { "vector_integer_T_swap", _wrap_vector_integer_T_swap, METH_VARARGS, "vector_integer_T_swap(vector_integer_T self, vector_integer_T v)"},
+	 { "vector_integer_T_begin", _wrap_vector_integer_T_begin, METH_O, "vector_integer_T_begin(vector_integer_T self) -> std::vector< int >::iterator"},
+	 { "vector_integer_T_end", _wrap_vector_integer_T_end, METH_O, "vector_integer_T_end(vector_integer_T self) -> std::vector< int >::iterator"},
+	 { "vector_integer_T_rbegin", _wrap_vector_integer_T_rbegin, METH_O, "vector_integer_T_rbegin(vector_integer_T self) -> std::vector< int >::reverse_iterator"},
+	 { "vector_integer_T_rend", _wrap_vector_integer_T_rend, METH_O, "vector_integer_T_rend(vector_integer_T self) -> std::vector< int >::reverse_iterator"},
+	 { "vector_integer_T_clear", _wrap_vector_integer_T_clear, METH_O, "vector_integer_T_clear(vector_integer_T self)"},
+	 { "vector_integer_T_get_allocator", _wrap_vector_integer_T_get_allocator, METH_O, "vector_integer_T_get_allocator(vector_integer_T self) -> std::vector< int >::allocator_type"},
+	 { "vector_integer_T_pop_back", _wrap_vector_integer_T_pop_back, METH_O, "vector_integer_T_pop_back(vector_integer_T self)"},
+	 { "vector_integer_T_erase", _wrap_vector_integer_T_erase, METH_VARARGS, "\n"
+		"vector_integer_T_erase(vector_integer_T self, std::vector< int >::iterator pos) -> std::vector< int >::iterator\n"
+		"vector_integer_T_erase(vector_integer_T self, std::vector< int >::iterator first, std::vector< int >::iterator last) -> std::vector< int >::iterator\n"
 		""},
-	 { "new_vector_integer_t", _wrap_new_vector_integer_t, METH_VARARGS, "\n"
-		"vector_integer_t()\n"
-		"vector_integer_t(vector_integer_t other)\n"
-		"vector_integer_t(std::vector< int >::size_type size)\n"
-		"new_vector_integer_t(std::vector< int >::size_type size, std::vector< int >::value_type const & value) -> vector_integer_t\n"
+	 { "new_vector_integer_T", _wrap_new_vector_integer_T, METH_VARARGS, "\n"
+		"vector_integer_T()\n"
+		"vector_integer_T(vector_integer_T other)\n"
+		"vector_integer_T(std::vector< int >::size_type size)\n"
+		"new_vector_integer_T(std::vector< int >::size_type size, std::vector< int >::value_type const & value) -> vector_integer_T\n"
 		""},
-	 { "vector_integer_t_push_back", _wrap_vector_integer_t_push_back, METH_VARARGS, "vector_integer_t_push_back(vector_integer_t self, std::vector< int >::value_type const & x)"},
-	 { "vector_integer_t_front", _wrap_vector_integer_t_front, METH_O, "vector_integer_t_front(vector_integer_t self) -> std::vector< int >::value_type const &"},
-	 { "vector_integer_t_back", _wrap_vector_integer_t_back, METH_O, "vector_integer_t_back(vector_integer_t self) -> std::vector< int >::value_type const &"},
-	 { "vector_integer_t_assign", _wrap_vector_integer_t_assign, METH_VARARGS, "vector_integer_t_assign(vector_integer_t self, std::vector< int >::size_type n, std::vector< int >::value_type const & x)"},
-	 { "vector_integer_t_resize", _wrap_vector_integer_t_resize, METH_VARARGS, "\n"
-		"vector_integer_t_resize(vector_integer_t self, std::vector< int >::size_type new_size)\n"
-		"vector_integer_t_resize(vector_integer_t self, std::vector< int >::size_type new_size, std::vector< int >::value_type const & x)\n"
+	 { "vector_integer_T_push_back", _wrap_vector_integer_T_push_back, METH_VARARGS, "vector_integer_T_push_back(vector_integer_T self, std::vector< int >::value_type const & x)"},
+	 { "vector_integer_T_front", _wrap_vector_integer_T_front, METH_O, "vector_integer_T_front(vector_integer_T self) -> std::vector< int >::value_type const &"},
+	 { "vector_integer_T_back", _wrap_vector_integer_T_back, METH_O, "vector_integer_T_back(vector_integer_T self) -> std::vector< int >::value_type const &"},
+	 { "vector_integer_T_assign", _wrap_vector_integer_T_assign, METH_VARARGS, "vector_integer_T_assign(vector_integer_T self, std::vector< int >::size_type n, std::vector< int >::value_type const & x)"},
+	 { "vector_integer_T_resize", _wrap_vector_integer_T_resize, METH_VARARGS, "\n"
+		"vector_integer_T_resize(vector_integer_T self, std::vector< int >::size_type new_size)\n"
+		"vector_integer_T_resize(vector_integer_T self, std::vector< int >::size_type new_size, std::vector< int >::value_type const & x)\n"
 		""},
-	 { "vector_integer_t_insert", _wrap_vector_integer_t_insert, METH_VARARGS, "\n"
-		"vector_integer_t_insert(vector_integer_t self, std::vector< int >::iterator pos, std::vector< int >::value_type const & x) -> std::vector< int >::iterator\n"
-		"vector_integer_t_insert(vector_integer_t self, std::vector< int >::iterator pos, std::vector< int >::size_type n, std::vector< int >::value_type const & x)\n"
+	 { "vector_integer_T_insert", _wrap_vector_integer_T_insert, METH_VARARGS, "\n"
+		"vector_integer_T_insert(vector_integer_T self, std::vector< int >::iterator pos, std::vector< int >::value_type const & x) -> std::vector< int >::iterator\n"
+		"vector_integer_T_insert(vector_integer_T self, std::vector< int >::iterator pos, std::vector< int >::size_type n, std::vector< int >::value_type const & x)\n"
 		""},
-	 { "vector_integer_t_reserve", _wrap_vector_integer_t_reserve, METH_VARARGS, "vector_integer_t_reserve(vector_integer_t self, std::vector< int >::size_type n)"},
-	 { "vector_integer_t_capacity", _wrap_vector_integer_t_capacity, METH_O, "vector_integer_t_capacity(vector_integer_t self) -> std::vector< int >::size_type"},
-	 { "delete_vector_integer_t", _wrap_delete_vector_integer_t, METH_O, "delete_vector_integer_t(vector_integer_t self)"},
-	 { "vector_integer_t_swigregister", vector_integer_t_swigregister, METH_O, NULL},
-	 { "vector_integer_t_swiginit", vector_integer_t_swiginit, METH_VARARGS, NULL},
-	 { "vinteger2d_t_iterator", _wrap_vinteger2d_t_iterator, METH_O, "vinteger2d_t_iterator(vinteger2d_t self) -> SwigPyIterator"},
-	 { "vinteger2d_t___nonzero__", _wrap_vinteger2d_t___nonzero__, METH_O, "vinteger2d_t___nonzero__(vinteger2d_t self) -> bool"},
-	 { "vinteger2d_t___bool__", _wrap_vinteger2d_t___bool__, METH_O, "vinteger2d_t___bool__(vinteger2d_t self) -> bool"},
-	 { "vinteger2d_t___len__", _wrap_vinteger2d_t___len__, METH_O, "vinteger2d_t___len__(vinteger2d_t self) -> std::vector< std::vector< int > >::size_type"},
-	 { "vinteger2d_t___getslice__", _wrap_vinteger2d_t___getslice__, METH_VARARGS, "vinteger2d_t___getslice__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j) -> vinteger2d_t"},
-	 { "vinteger2d_t___setslice__", _wrap_vinteger2d_t___setslice__, METH_VARARGS, "\n"
-		"vinteger2d_t___setslice__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j)\n"
-		"vinteger2d_t___setslice__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j, vinteger2d_t v)\n"
+	 { "vector_integer_T_reserve", _wrap_vector_integer_T_reserve, METH_VARARGS, "vector_integer_T_reserve(vector_integer_T self, std::vector< int >::size_type n)"},
+	 { "vector_integer_T_capacity", _wrap_vector_integer_T_capacity, METH_O, "vector_integer_T_capacity(vector_integer_T self) -> std::vector< int >::size_type"},
+	 { "delete_vector_integer_T", _wrap_delete_vector_integer_T, METH_O, "delete_vector_integer_T(vector_integer_T self)"},
+	 { "vector_integer_T_swigregister", vector_integer_T_swigregister, METH_O, NULL},
+	 { "vector_integer_T_swiginit", vector_integer_T_swiginit, METH_VARARGS, NULL},
+	 { "vinteger2d_T_iterator", _wrap_vinteger2d_T_iterator, METH_O, "vinteger2d_T_iterator(vinteger2d_T self) -> SwigPyIterator"},
+	 { "vinteger2d_T___nonzero__", _wrap_vinteger2d_T___nonzero__, METH_O, "vinteger2d_T___nonzero__(vinteger2d_T self) -> bool"},
+	 { "vinteger2d_T___bool__", _wrap_vinteger2d_T___bool__, METH_O, "vinteger2d_T___bool__(vinteger2d_T self) -> bool"},
+	 { "vinteger2d_T___len__", _wrap_vinteger2d_T___len__, METH_O, "vinteger2d_T___len__(vinteger2d_T self) -> std::vector< std::vector< int > >::size_type"},
+	 { "vinteger2d_T___getslice__", _wrap_vinteger2d_T___getslice__, METH_VARARGS, "vinteger2d_T___getslice__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j) -> vinteger2d_T"},
+	 { "vinteger2d_T___setslice__", _wrap_vinteger2d_T___setslice__, METH_VARARGS, "\n"
+		"vinteger2d_T___setslice__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j)\n"
+		"vinteger2d_T___setslice__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j, vinteger2d_T v)\n"
 		""},
-	 { "vinteger2d_t___delslice__", _wrap_vinteger2d_t___delslice__, METH_VARARGS, "vinteger2d_t___delslice__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j)"},
-	 { "vinteger2d_t___delitem__", _wrap_vinteger2d_t___delitem__, METH_VARARGS, "\n"
-		"vinteger2d_t___delitem__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i)\n"
-		"vinteger2d_t___delitem__(vinteger2d_t self, SWIGPY_SLICEOBJECT * slice)\n"
+	 { "vinteger2d_T___delslice__", _wrap_vinteger2d_T___delslice__, METH_VARARGS, "vinteger2d_T___delslice__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j)"},
+	 { "vinteger2d_T___delitem__", _wrap_vinteger2d_T___delitem__, METH_VARARGS, "\n"
+		"vinteger2d_T___delitem__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i)\n"
+		"vinteger2d_T___delitem__(vinteger2d_T self, SWIGPY_SLICEOBJECT * slice)\n"
 		""},
-	 { "vinteger2d_t___getitem__", _wrap_vinteger2d_t___getitem__, METH_VARARGS, "\n"
-		"vinteger2d_t___getitem__(vinteger2d_t self, SWIGPY_SLICEOBJECT * slice) -> vinteger2d_t\n"
-		"vinteger2d_t___getitem__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i) -> vector_integer_t\n"
+	 { "vinteger2d_T___getitem__", _wrap_vinteger2d_T___getitem__, METH_VARARGS, "\n"
+		"vinteger2d_T___getitem__(vinteger2d_T self, SWIGPY_SLICEOBJECT * slice) -> vinteger2d_T\n"
+		"vinteger2d_T___getitem__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i) -> vector_integer_T\n"
 		""},
-	 { "vinteger2d_t___setitem__", _wrap_vinteger2d_t___setitem__, METH_VARARGS, "\n"
-		"vinteger2d_t___setitem__(vinteger2d_t self, SWIGPY_SLICEOBJECT * slice, vinteger2d_t v)\n"
-		"vinteger2d_t___setitem__(vinteger2d_t self, SWIGPY_SLICEOBJECT * slice)\n"
-		"vinteger2d_t___setitem__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i, vector_integer_t x)\n"
+	 { "vinteger2d_T___setitem__", _wrap_vinteger2d_T___setitem__, METH_VARARGS, "\n"
+		"vinteger2d_T___setitem__(vinteger2d_T self, SWIGPY_SLICEOBJECT * slice, vinteger2d_T v)\n"
+		"vinteger2d_T___setitem__(vinteger2d_T self, SWIGPY_SLICEOBJECT * slice)\n"
+		"vinteger2d_T___setitem__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i, vector_integer_T x)\n"
 		""},
-	 { "vinteger2d_t_pop", _wrap_vinteger2d_t_pop, METH_O, "vinteger2d_t_pop(vinteger2d_t self) -> vector_integer_t"},
-	 { "vinteger2d_t_append", _wrap_vinteger2d_t_append, METH_VARARGS, "vinteger2d_t_append(vinteger2d_t self, vector_integer_t x)"},
-	 { "vinteger2d_t_empty", _wrap_vinteger2d_t_empty, METH_O, "vinteger2d_t_empty(vinteger2d_t self) -> bool"},
-	 { "vinteger2d_t_size", _wrap_vinteger2d_t_size, METH_O, "vinteger2d_t_size(vinteger2d_t self) -> std::vector< std::vector< int > >::size_type"},
-	 { "vinteger2d_t_swap", _wrap_vinteger2d_t_swap, METH_VARARGS, "vinteger2d_t_swap(vinteger2d_t self, vinteger2d_t v)"},
-	 { "vinteger2d_t_begin", _wrap_vinteger2d_t_begin, METH_O, "vinteger2d_t_begin(vinteger2d_t self) -> std::vector< std::vector< int > >::iterator"},
-	 { "vinteger2d_t_end", _wrap_vinteger2d_t_end, METH_O, "vinteger2d_t_end(vinteger2d_t self) -> std::vector< std::vector< int > >::iterator"},
-	 { "vinteger2d_t_rbegin", _wrap_vinteger2d_t_rbegin, METH_O, "vinteger2d_t_rbegin(vinteger2d_t self) -> std::vector< std::vector< int > >::reverse_iterator"},
-	 { "vinteger2d_t_rend", _wrap_vinteger2d_t_rend, METH_O, "vinteger2d_t_rend(vinteger2d_t self) -> std::vector< std::vector< int > >::reverse_iterator"},
-	 { "vinteger2d_t_clear", _wrap_vinteger2d_t_clear, METH_O, "vinteger2d_t_clear(vinteger2d_t self)"},
-	 { "vinteger2d_t_get_allocator", _wrap_vinteger2d_t_get_allocator, METH_O, "vinteger2d_t_get_allocator(vinteger2d_t self) -> std::vector< std::vector< int > >::allocator_type"},
-	 { "vinteger2d_t_pop_back", _wrap_vinteger2d_t_pop_back, METH_O, "vinteger2d_t_pop_back(vinteger2d_t self)"},
-	 { "vinteger2d_t_erase", _wrap_vinteger2d_t_erase, METH_VARARGS, "\n"
-		"vinteger2d_t_erase(vinteger2d_t self, std::vector< std::vector< int > >::iterator pos) -> std::vector< std::vector< int > >::iterator\n"
-		"vinteger2d_t_erase(vinteger2d_t self, std::vector< std::vector< int > >::iterator first, std::vector< std::vector< int > >::iterator last) -> std::vector< std::vector< int > >::iterator\n"
+	 { "vinteger2d_T_pop", _wrap_vinteger2d_T_pop, METH_O, "vinteger2d_T_pop(vinteger2d_T self) -> vector_integer_T"},
+	 { "vinteger2d_T_append", _wrap_vinteger2d_T_append, METH_VARARGS, "vinteger2d_T_append(vinteger2d_T self, vector_integer_T x)"},
+	 { "vinteger2d_T_empty", _wrap_vinteger2d_T_empty, METH_O, "vinteger2d_T_empty(vinteger2d_T self) -> bool"},
+	 { "vinteger2d_T_size", _wrap_vinteger2d_T_size, METH_O, "vinteger2d_T_size(vinteger2d_T self) -> std::vector< std::vector< int > >::size_type"},
+	 { "vinteger2d_T_swap", _wrap_vinteger2d_T_swap, METH_VARARGS, "vinteger2d_T_swap(vinteger2d_T self, vinteger2d_T v)"},
+	 { "vinteger2d_T_begin", _wrap_vinteger2d_T_begin, METH_O, "vinteger2d_T_begin(vinteger2d_T self) -> std::vector< std::vector< int > >::iterator"},
+	 { "vinteger2d_T_end", _wrap_vinteger2d_T_end, METH_O, "vinteger2d_T_end(vinteger2d_T self) -> std::vector< std::vector< int > >::iterator"},
+	 { "vinteger2d_T_rbegin", _wrap_vinteger2d_T_rbegin, METH_O, "vinteger2d_T_rbegin(vinteger2d_T self) -> std::vector< std::vector< int > >::reverse_iterator"},
+	 { "vinteger2d_T_rend", _wrap_vinteger2d_T_rend, METH_O, "vinteger2d_T_rend(vinteger2d_T self) -> std::vector< std::vector< int > >::reverse_iterator"},
+	 { "vinteger2d_T_clear", _wrap_vinteger2d_T_clear, METH_O, "vinteger2d_T_clear(vinteger2d_T self)"},
+	 { "vinteger2d_T_get_allocator", _wrap_vinteger2d_T_get_allocator, METH_O, "vinteger2d_T_get_allocator(vinteger2d_T self) -> std::vector< std::vector< int > >::allocator_type"},
+	 { "vinteger2d_T_pop_back", _wrap_vinteger2d_T_pop_back, METH_O, "vinteger2d_T_pop_back(vinteger2d_T self)"},
+	 { "vinteger2d_T_erase", _wrap_vinteger2d_T_erase, METH_VARARGS, "\n"
+		"vinteger2d_T_erase(vinteger2d_T self, std::vector< std::vector< int > >::iterator pos) -> std::vector< std::vector< int > >::iterator\n"
+		"vinteger2d_T_erase(vinteger2d_T self, std::vector< std::vector< int > >::iterator first, std::vector< std::vector< int > >::iterator last) -> std::vector< std::vector< int > >::iterator\n"
 		""},
-	 { "new_vinteger2d_t", _wrap_new_vinteger2d_t, METH_VARARGS, "\n"
-		"vinteger2d_t()\n"
-		"vinteger2d_t(vinteger2d_t other)\n"
-		"vinteger2d_t(std::vector< std::vector< int > >::size_type size)\n"
-		"new_vinteger2d_t(std::vector< std::vector< int > >::size_type size, vector_integer_t value) -> vinteger2d_t\n"
+	 { "new_vinteger2d_T", _wrap_new_vinteger2d_T, METH_VARARGS, "\n"
+		"vinteger2d_T()\n"
+		"vinteger2d_T(vinteger2d_T other)\n"
+		"vinteger2d_T(std::vector< std::vector< int > >::size_type size)\n"
+		"new_vinteger2d_T(std::vector< std::vector< int > >::size_type size, vector_integer_T value) -> vinteger2d_T\n"
 		""},
-	 { "vinteger2d_t_push_back", _wrap_vinteger2d_t_push_back, METH_VARARGS, "vinteger2d_t_push_back(vinteger2d_t self, vector_integer_t x)"},
-	 { "vinteger2d_t_front", _wrap_vinteger2d_t_front, METH_O, "vinteger2d_t_front(vinteger2d_t self) -> vector_integer_t"},
-	 { "vinteger2d_t_back", _wrap_vinteger2d_t_back, METH_O, "vinteger2d_t_back(vinteger2d_t self) -> vector_integer_t"},
-	 { "vinteger2d_t_assign", _wrap_vinteger2d_t_assign, METH_VARARGS, "vinteger2d_t_assign(vinteger2d_t self, std::vector< std::vector< int > >::size_type n, vector_integer_t x)"},
-	 { "vinteger2d_t_resize", _wrap_vinteger2d_t_resize, METH_VARARGS, "\n"
-		"vinteger2d_t_resize(vinteger2d_t self, std::vector< std::vector< int > >::size_type new_size)\n"
-		"vinteger2d_t_resize(vinteger2d_t self, std::vector< std::vector< int > >::size_type new_size, vector_integer_t x)\n"
+	 { "vinteger2d_T_push_back", _wrap_vinteger2d_T_push_back, METH_VARARGS, "vinteger2d_T_push_back(vinteger2d_T self, vector_integer_T x)"},
+	 { "vinteger2d_T_front", _wrap_vinteger2d_T_front, METH_O, "vinteger2d_T_front(vinteger2d_T self) -> vector_integer_T"},
+	 { "vinteger2d_T_back", _wrap_vinteger2d_T_back, METH_O, "vinteger2d_T_back(vinteger2d_T self) -> vector_integer_T"},
+	 { "vinteger2d_T_assign", _wrap_vinteger2d_T_assign, METH_VARARGS, "vinteger2d_T_assign(vinteger2d_T self, std::vector< std::vector< int > >::size_type n, vector_integer_T x)"},
+	 { "vinteger2d_T_resize", _wrap_vinteger2d_T_resize, METH_VARARGS, "\n"
+		"vinteger2d_T_resize(vinteger2d_T self, std::vector< std::vector< int > >::size_type new_size)\n"
+		"vinteger2d_T_resize(vinteger2d_T self, std::vector< std::vector< int > >::size_type new_size, vector_integer_T x)\n"
 		""},
-	 { "vinteger2d_t_insert", _wrap_vinteger2d_t_insert, METH_VARARGS, "\n"
-		"vinteger2d_t_insert(vinteger2d_t self, std::vector< std::vector< int > >::iterator pos, vector_integer_t x) -> std::vector< std::vector< int > >::iterator\n"
-		"vinteger2d_t_insert(vinteger2d_t self, std::vector< std::vector< int > >::iterator pos, std::vector< std::vector< int > >::size_type n, vector_integer_t x)\n"
+	 { "vinteger2d_T_insert", _wrap_vinteger2d_T_insert, METH_VARARGS, "\n"
+		"vinteger2d_T_insert(vinteger2d_T self, std::vector< std::vector< int > >::iterator pos, vector_integer_T x) -> std::vector< std::vector< int > >::iterator\n"
+		"vinteger2d_T_insert(vinteger2d_T self, std::vector< std::vector< int > >::iterator pos, std::vector< std::vector< int > >::size_type n, vector_integer_T x)\n"
 		""},
-	 { "vinteger2d_t_reserve", _wrap_vinteger2d_t_reserve, METH_VARARGS, "vinteger2d_t_reserve(vinteger2d_t self, std::vector< std::vector< int > >::size_type n)"},
-	 { "vinteger2d_t_capacity", _wrap_vinteger2d_t_capacity, METH_O, "vinteger2d_t_capacity(vinteger2d_t self) -> std::vector< std::vector< int > >::size_type"},
-	 { "delete_vinteger2d_t", _wrap_delete_vinteger2d_t, METH_O, "delete_vinteger2d_t(vinteger2d_t self)"},
-	 { "vinteger2d_t_swigregister", vinteger2d_t_swigregister, METH_O, NULL},
-	 { "vinteger2d_t_swiginit", vinteger2d_t_swiginit, METH_VARARGS, NULL},
-	 { "vector_longinteger_t_iterator", _wrap_vector_longinteger_t_iterator, METH_O, "vector_longinteger_t_iterator(vector_longinteger_t self) -> SwigPyIterator"},
-	 { "vector_longinteger_t___nonzero__", _wrap_vector_longinteger_t___nonzero__, METH_O, "vector_longinteger_t___nonzero__(vector_longinteger_t self) -> bool"},
-	 { "vector_longinteger_t___bool__", _wrap_vector_longinteger_t___bool__, METH_O, "vector_longinteger_t___bool__(vector_longinteger_t self) -> bool"},
-	 { "vector_longinteger_t___len__", _wrap_vector_longinteger_t___len__, METH_O, "vector_longinteger_t___len__(vector_longinteger_t self) -> std::vector< unsigned long >::size_type"},
-	 { "vector_longinteger_t___getslice__", _wrap_vector_longinteger_t___getslice__, METH_VARARGS, "vector_longinteger_t___getslice__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j) -> vector_longinteger_t"},
-	 { "vector_longinteger_t___setslice__", _wrap_vector_longinteger_t___setslice__, METH_VARARGS, "\n"
-		"vector_longinteger_t___setslice__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j)\n"
-		"vector_longinteger_t___setslice__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j, vector_longinteger_t v)\n"
+	 { "vinteger2d_T_reserve", _wrap_vinteger2d_T_reserve, METH_VARARGS, "vinteger2d_T_reserve(vinteger2d_T self, std::vector< std::vector< int > >::size_type n)"},
+	 { "vinteger2d_T_capacity", _wrap_vinteger2d_T_capacity, METH_O, "vinteger2d_T_capacity(vinteger2d_T self) -> std::vector< std::vector< int > >::size_type"},
+	 { "delete_vinteger2d_T", _wrap_delete_vinteger2d_T, METH_O, "delete_vinteger2d_T(vinteger2d_T self)"},
+	 { "vinteger2d_T_swigregister", vinteger2d_T_swigregister, METH_O, NULL},
+	 { "vinteger2d_T_swiginit", vinteger2d_T_swiginit, METH_VARARGS, NULL},
+	 { "vector_longinteger_T_iterator", _wrap_vector_longinteger_T_iterator, METH_O, "vector_longinteger_T_iterator(vector_longinteger_T self) -> SwigPyIterator"},
+	 { "vector_longinteger_T___nonzero__", _wrap_vector_longinteger_T___nonzero__, METH_O, "vector_longinteger_T___nonzero__(vector_longinteger_T self) -> bool"},
+	 { "vector_longinteger_T___bool__", _wrap_vector_longinteger_T___bool__, METH_O, "vector_longinteger_T___bool__(vector_longinteger_T self) -> bool"},
+	 { "vector_longinteger_T___len__", _wrap_vector_longinteger_T___len__, METH_O, "vector_longinteger_T___len__(vector_longinteger_T self) -> std::vector< unsigned long >::size_type"},
+	 { "vector_longinteger_T___getslice__", _wrap_vector_longinteger_T___getslice__, METH_VARARGS, "vector_longinteger_T___getslice__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j) -> vector_longinteger_T"},
+	 { "vector_longinteger_T___setslice__", _wrap_vector_longinteger_T___setslice__, METH_VARARGS, "\n"
+		"vector_longinteger_T___setslice__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j)\n"
+		"vector_longinteger_T___setslice__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j, vector_longinteger_T v)\n"
 		""},
-	 { "vector_longinteger_t___delslice__", _wrap_vector_longinteger_t___delslice__, METH_VARARGS, "vector_longinteger_t___delslice__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j)"},
-	 { "vector_longinteger_t___delitem__", _wrap_vector_longinteger_t___delitem__, METH_VARARGS, "\n"
-		"vector_longinteger_t___delitem__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i)\n"
-		"vector_longinteger_t___delitem__(vector_longinteger_t self, SWIGPY_SLICEOBJECT * slice)\n"
+	 { "vector_longinteger_T___delslice__", _wrap_vector_longinteger_T___delslice__, METH_VARARGS, "vector_longinteger_T___delslice__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j)"},
+	 { "vector_longinteger_T___delitem__", _wrap_vector_longinteger_T___delitem__, METH_VARARGS, "\n"
+		"vector_longinteger_T___delitem__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i)\n"
+		"vector_longinteger_T___delitem__(vector_longinteger_T self, SWIGPY_SLICEOBJECT * slice)\n"
 		""},
-	 { "vector_longinteger_t___getitem__", _wrap_vector_longinteger_t___getitem__, METH_VARARGS, "\n"
-		"vector_longinteger_t___getitem__(vector_longinteger_t self, SWIGPY_SLICEOBJECT * slice) -> vector_longinteger_t\n"
-		"vector_longinteger_t___getitem__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i) -> std::vector< unsigned long >::value_type const &\n"
+	 { "vector_longinteger_T___getitem__", _wrap_vector_longinteger_T___getitem__, METH_VARARGS, "\n"
+		"vector_longinteger_T___getitem__(vector_longinteger_T self, SWIGPY_SLICEOBJECT * slice) -> vector_longinteger_T\n"
+		"vector_longinteger_T___getitem__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i) -> std::vector< unsigned long >::value_type const &\n"
 		""},
-	 { "vector_longinteger_t___setitem__", _wrap_vector_longinteger_t___setitem__, METH_VARARGS, "\n"
-		"vector_longinteger_t___setitem__(vector_longinteger_t self, SWIGPY_SLICEOBJECT * slice, vector_longinteger_t v)\n"
-		"vector_longinteger_t___setitem__(vector_longinteger_t self, SWIGPY_SLICEOBJECT * slice)\n"
-		"vector_longinteger_t___setitem__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::value_type const & x)\n"
+	 { "vector_longinteger_T___setitem__", _wrap_vector_longinteger_T___setitem__, METH_VARARGS, "\n"
+		"vector_longinteger_T___setitem__(vector_longinteger_T self, SWIGPY_SLICEOBJECT * slice, vector_longinteger_T v)\n"
+		"vector_longinteger_T___setitem__(vector_longinteger_T self, SWIGPY_SLICEOBJECT * slice)\n"
+		"vector_longinteger_T___setitem__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::value_type const & x)\n"
 		""},
-	 { "vector_longinteger_t_pop", _wrap_vector_longinteger_t_pop, METH_O, "vector_longinteger_t_pop(vector_longinteger_t self) -> std::vector< unsigned long >::value_type"},
-	 { "vector_longinteger_t_append", _wrap_vector_longinteger_t_append, METH_VARARGS, "vector_longinteger_t_append(vector_longinteger_t self, std::vector< unsigned long >::value_type const & x)"},
-	 { "vector_longinteger_t_empty", _wrap_vector_longinteger_t_empty, METH_O, "vector_longinteger_t_empty(vector_longinteger_t self) -> bool"},
-	 { "vector_longinteger_t_size", _wrap_vector_longinteger_t_size, METH_O, "vector_longinteger_t_size(vector_longinteger_t self) -> std::vector< unsigned long >::size_type"},
-	 { "vector_longinteger_t_swap", _wrap_vector_longinteger_t_swap, METH_VARARGS, "vector_longinteger_t_swap(vector_longinteger_t self, vector_longinteger_t v)"},
-	 { "vector_longinteger_t_begin", _wrap_vector_longinteger_t_begin, METH_O, "vector_longinteger_t_begin(vector_longinteger_t self) -> std::vector< unsigned long >::iterator"},
-	 { "vector_longinteger_t_end", _wrap_vector_longinteger_t_end, METH_O, "vector_longinteger_t_end(vector_longinteger_t self) -> std::vector< unsigned long >::iterator"},
-	 { "vector_longinteger_t_rbegin", _wrap_vector_longinteger_t_rbegin, METH_O, "vector_longinteger_t_rbegin(vector_longinteger_t self) -> std::vector< unsigned long >::reverse_iterator"},
-	 { "vector_longinteger_t_rend", _wrap_vector_longinteger_t_rend, METH_O, "vector_longinteger_t_rend(vector_longinteger_t self) -> std::vector< unsigned long >::reverse_iterator"},
-	 { "vector_longinteger_t_clear", _wrap_vector_longinteger_t_clear, METH_O, "vector_longinteger_t_clear(vector_longinteger_t self)"},
-	 { "vector_longinteger_t_get_allocator", _wrap_vector_longinteger_t_get_allocator, METH_O, "vector_longinteger_t_get_allocator(vector_longinteger_t self) -> std::vector< unsigned long >::allocator_type"},
-	 { "vector_longinteger_t_pop_back", _wrap_vector_longinteger_t_pop_back, METH_O, "vector_longinteger_t_pop_back(vector_longinteger_t self)"},
-	 { "vector_longinteger_t_erase", _wrap_vector_longinteger_t_erase, METH_VARARGS, "\n"
-		"vector_longinteger_t_erase(vector_longinteger_t self, std::vector< unsigned long >::iterator pos) -> std::vector< unsigned long >::iterator\n"
-		"vector_longinteger_t_erase(vector_longinteger_t self, std::vector< unsigned long >::iterator first, std::vector< unsigned long >::iterator last) -> std::vector< unsigned long >::iterator\n"
+	 { "vector_longinteger_T_pop", _wrap_vector_longinteger_T_pop, METH_O, "vector_longinteger_T_pop(vector_longinteger_T self) -> std::vector< unsigned long >::value_type"},
+	 { "vector_longinteger_T_append", _wrap_vector_longinteger_T_append, METH_VARARGS, "vector_longinteger_T_append(vector_longinteger_T self, std::vector< unsigned long >::value_type const & x)"},
+	 { "vector_longinteger_T_empty", _wrap_vector_longinteger_T_empty, METH_O, "vector_longinteger_T_empty(vector_longinteger_T self) -> bool"},
+	 { "vector_longinteger_T_size", _wrap_vector_longinteger_T_size, METH_O, "vector_longinteger_T_size(vector_longinteger_T self) -> std::vector< unsigned long >::size_type"},
+	 { "vector_longinteger_T_swap", _wrap_vector_longinteger_T_swap, METH_VARARGS, "vector_longinteger_T_swap(vector_longinteger_T self, vector_longinteger_T v)"},
+	 { "vector_longinteger_T_begin", _wrap_vector_longinteger_T_begin, METH_O, "vector_longinteger_T_begin(vector_longinteger_T self) -> std::vector< unsigned long >::iterator"},
+	 { "vector_longinteger_T_end", _wrap_vector_longinteger_T_end, METH_O, "vector_longinteger_T_end(vector_longinteger_T self) -> std::vector< unsigned long >::iterator"},
+	 { "vector_longinteger_T_rbegin", _wrap_vector_longinteger_T_rbegin, METH_O, "vector_longinteger_T_rbegin(vector_longinteger_T self) -> std::vector< unsigned long >::reverse_iterator"},
+	 { "vector_longinteger_T_rend", _wrap_vector_longinteger_T_rend, METH_O, "vector_longinteger_T_rend(vector_longinteger_T self) -> std::vector< unsigned long >::reverse_iterator"},
+	 { "vector_longinteger_T_clear", _wrap_vector_longinteger_T_clear, METH_O, "vector_longinteger_T_clear(vector_longinteger_T self)"},
+	 { "vector_longinteger_T_get_allocator", _wrap_vector_longinteger_T_get_allocator, METH_O, "vector_longinteger_T_get_allocator(vector_longinteger_T self) -> std::vector< unsigned long >::allocator_type"},
+	 { "vector_longinteger_T_pop_back", _wrap_vector_longinteger_T_pop_back, METH_O, "vector_longinteger_T_pop_back(vector_longinteger_T self)"},
+	 { "vector_longinteger_T_erase", _wrap_vector_longinteger_T_erase, METH_VARARGS, "\n"
+		"vector_longinteger_T_erase(vector_longinteger_T self, std::vector< unsigned long >::iterator pos) -> std::vector< unsigned long >::iterator\n"
+		"vector_longinteger_T_erase(vector_longinteger_T self, std::vector< unsigned long >::iterator first, std::vector< unsigned long >::iterator last) -> std::vector< unsigned long >::iterator\n"
 		""},
-	 { "new_vector_longinteger_t", _wrap_new_vector_longinteger_t, METH_VARARGS, "\n"
-		"vector_longinteger_t()\n"
-		"vector_longinteger_t(vector_longinteger_t other)\n"
-		"vector_longinteger_t(std::vector< unsigned long >::size_type size)\n"
-		"new_vector_longinteger_t(std::vector< unsigned long >::size_type size, std::vector< unsigned long >::value_type const & value) -> vector_longinteger_t\n"
+	 { "new_vector_longinteger_T", _wrap_new_vector_longinteger_T, METH_VARARGS, "\n"
+		"vector_longinteger_T()\n"
+		"vector_longinteger_T(vector_longinteger_T other)\n"
+		"vector_longinteger_T(std::vector< unsigned long >::size_type size)\n"
+		"new_vector_longinteger_T(std::vector< unsigned long >::size_type size, std::vector< unsigned long >::value_type const & value) -> vector_longinteger_T\n"
 		""},
-	 { "vector_longinteger_t_push_back", _wrap_vector_longinteger_t_push_back, METH_VARARGS, "vector_longinteger_t_push_back(vector_longinteger_t self, std::vector< unsigned long >::value_type const & x)"},
-	 { "vector_longinteger_t_front", _wrap_vector_longinteger_t_front, METH_O, "vector_longinteger_t_front(vector_longinteger_t self) -> std::vector< unsigned long >::value_type const &"},
-	 { "vector_longinteger_t_back", _wrap_vector_longinteger_t_back, METH_O, "vector_longinteger_t_back(vector_longinteger_t self) -> std::vector< unsigned long >::value_type const &"},
-	 { "vector_longinteger_t_assign", _wrap_vector_longinteger_t_assign, METH_VARARGS, "vector_longinteger_t_assign(vector_longinteger_t self, std::vector< unsigned long >::size_type n, std::vector< unsigned long >::value_type const & x)"},
-	 { "vector_longinteger_t_resize", _wrap_vector_longinteger_t_resize, METH_VARARGS, "\n"
-		"vector_longinteger_t_resize(vector_longinteger_t self, std::vector< unsigned long >::size_type new_size)\n"
-		"vector_longinteger_t_resize(vector_longinteger_t self, std::vector< unsigned long >::size_type new_size, std::vector< unsigned long >::value_type const & x)\n"
+	 { "vector_longinteger_T_push_back", _wrap_vector_longinteger_T_push_back, METH_VARARGS, "vector_longinteger_T_push_back(vector_longinteger_T self, std::vector< unsigned long >::value_type const & x)"},
+	 { "vector_longinteger_T_front", _wrap_vector_longinteger_T_front, METH_O, "vector_longinteger_T_front(vector_longinteger_T self) -> std::vector< unsigned long >::value_type const &"},
+	 { "vector_longinteger_T_back", _wrap_vector_longinteger_T_back, METH_O, "vector_longinteger_T_back(vector_longinteger_T self) -> std::vector< unsigned long >::value_type const &"},
+	 { "vector_longinteger_T_assign", _wrap_vector_longinteger_T_assign, METH_VARARGS, "vector_longinteger_T_assign(vector_longinteger_T self, std::vector< unsigned long >::size_type n, std::vector< unsigned long >::value_type const & x)"},
+	 { "vector_longinteger_T_resize", _wrap_vector_longinteger_T_resize, METH_VARARGS, "\n"
+		"vector_longinteger_T_resize(vector_longinteger_T self, std::vector< unsigned long >::size_type new_size)\n"
+		"vector_longinteger_T_resize(vector_longinteger_T self, std::vector< unsigned long >::size_type new_size, std::vector< unsigned long >::value_type const & x)\n"
 		""},
-	 { "vector_longinteger_t_insert", _wrap_vector_longinteger_t_insert, METH_VARARGS, "\n"
-		"vector_longinteger_t_insert(vector_longinteger_t self, std::vector< unsigned long >::iterator pos, std::vector< unsigned long >::value_type const & x) -> std::vector< unsigned long >::iterator\n"
-		"vector_longinteger_t_insert(vector_longinteger_t self, std::vector< unsigned long >::iterator pos, std::vector< unsigned long >::size_type n, std::vector< unsigned long >::value_type const & x)\n"
+	 { "vector_longinteger_T_insert", _wrap_vector_longinteger_T_insert, METH_VARARGS, "\n"
+		"vector_longinteger_T_insert(vector_longinteger_T self, std::vector< unsigned long >::iterator pos, std::vector< unsigned long >::value_type const & x) -> std::vector< unsigned long >::iterator\n"
+		"vector_longinteger_T_insert(vector_longinteger_T self, std::vector< unsigned long >::iterator pos, std::vector< unsigned long >::size_type n, std::vector< unsigned long >::value_type const & x)\n"
 		""},
-	 { "vector_longinteger_t_reserve", _wrap_vector_longinteger_t_reserve, METH_VARARGS, "vector_longinteger_t_reserve(vector_longinteger_t self, std::vector< unsigned long >::size_type n)"},
-	 { "vector_longinteger_t_capacity", _wrap_vector_longinteger_t_capacity, METH_O, "vector_longinteger_t_capacity(vector_longinteger_t self) -> std::vector< unsigned long >::size_type"},
-	 { "delete_vector_longinteger_t", _wrap_delete_vector_longinteger_t, METH_O, "delete_vector_longinteger_t(vector_longinteger_t self)"},
-	 { "vector_longinteger_t_swigregister", vector_longinteger_t_swigregister, METH_O, NULL},
-	 { "vector_longinteger_t_swiginit", vector_longinteger_t_swiginit, METH_VARARGS, NULL},
-	 { "vector_complex_t_iterator", _wrap_vector_complex_t_iterator, METH_O, "vector_complex_t_iterator(vector_complex_t self) -> SwigPyIterator"},
-	 { "vector_complex_t___nonzero__", _wrap_vector_complex_t___nonzero__, METH_O, "vector_complex_t___nonzero__(vector_complex_t self) -> bool"},
-	 { "vector_complex_t___bool__", _wrap_vector_complex_t___bool__, METH_O, "vector_complex_t___bool__(vector_complex_t self) -> bool"},
-	 { "vector_complex_t___len__", _wrap_vector_complex_t___len__, METH_O, "vector_complex_t___len__(vector_complex_t self) -> std::vector< std::complex< double > >::size_type"},
-	 { "vector_complex_t___getslice__", _wrap_vector_complex_t___getslice__, METH_VARARGS, "vector_complex_t___getslice__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j) -> vector_complex_t"},
-	 { "vector_complex_t___setslice__", _wrap_vector_complex_t___setslice__, METH_VARARGS, "\n"
-		"vector_complex_t___setslice__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j)\n"
-		"vector_complex_t___setslice__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j, vector_complex_t v)\n"
+	 { "vector_longinteger_T_reserve", _wrap_vector_longinteger_T_reserve, METH_VARARGS, "vector_longinteger_T_reserve(vector_longinteger_T self, std::vector< unsigned long >::size_type n)"},
+	 { "vector_longinteger_T_capacity", _wrap_vector_longinteger_T_capacity, METH_O, "vector_longinteger_T_capacity(vector_longinteger_T self) -> std::vector< unsigned long >::size_type"},
+	 { "delete_vector_longinteger_T", _wrap_delete_vector_longinteger_T, METH_O, "delete_vector_longinteger_T(vector_longinteger_T self)"},
+	 { "vector_longinteger_T_swigregister", vector_longinteger_T_swigregister, METH_O, NULL},
+	 { "vector_longinteger_T_swiginit", vector_longinteger_T_swiginit, METH_VARARGS, NULL},
+	 { "vector_complex_T_iterator", _wrap_vector_complex_T_iterator, METH_O, "vector_complex_T_iterator(vector_complex_T self) -> SwigPyIterator"},
+	 { "vector_complex_T___nonzero__", _wrap_vector_complex_T___nonzero__, METH_O, "vector_complex_T___nonzero__(vector_complex_T self) -> bool"},
+	 { "vector_complex_T___bool__", _wrap_vector_complex_T___bool__, METH_O, "vector_complex_T___bool__(vector_complex_T self) -> bool"},
+	 { "vector_complex_T___len__", _wrap_vector_complex_T___len__, METH_O, "vector_complex_T___len__(vector_complex_T self) -> std::vector< std::complex< double > >::size_type"},
+	 { "vector_complex_T___getslice__", _wrap_vector_complex_T___getslice__, METH_VARARGS, "vector_complex_T___getslice__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j) -> vector_complex_T"},
+	 { "vector_complex_T___setslice__", _wrap_vector_complex_T___setslice__, METH_VARARGS, "\n"
+		"vector_complex_T___setslice__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j)\n"
+		"vector_complex_T___setslice__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j, vector_complex_T v)\n"
 		""},
-	 { "vector_complex_t___delslice__", _wrap_vector_complex_t___delslice__, METH_VARARGS, "vector_complex_t___delslice__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j)"},
-	 { "vector_complex_t___delitem__", _wrap_vector_complex_t___delitem__, METH_VARARGS, "\n"
-		"vector_complex_t___delitem__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i)\n"
-		"vector_complex_t___delitem__(vector_complex_t self, SWIGPY_SLICEOBJECT * slice)\n"
+	 { "vector_complex_T___delslice__", _wrap_vector_complex_T___delslice__, METH_VARARGS, "vector_complex_T___delslice__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j)"},
+	 { "vector_complex_T___delitem__", _wrap_vector_complex_T___delitem__, METH_VARARGS, "\n"
+		"vector_complex_T___delitem__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i)\n"
+		"vector_complex_T___delitem__(vector_complex_T self, SWIGPY_SLICEOBJECT * slice)\n"
 		""},
-	 { "vector_complex_t___getitem__", _wrap_vector_complex_t___getitem__, METH_VARARGS, "\n"
-		"vector_complex_t___getitem__(vector_complex_t self, SWIGPY_SLICEOBJECT * slice) -> vector_complex_t\n"
-		"vector_complex_t___getitem__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i) -> std::vector< std::complex< double > >::value_type const &\n"
+	 { "vector_complex_T___getitem__", _wrap_vector_complex_T___getitem__, METH_VARARGS, "\n"
+		"vector_complex_T___getitem__(vector_complex_T self, SWIGPY_SLICEOBJECT * slice) -> vector_complex_T\n"
+		"vector_complex_T___getitem__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i) -> std::vector< std::complex< double > >::value_type const &\n"
 		""},
-	 { "vector_complex_t___setitem__", _wrap_vector_complex_t___setitem__, METH_VARARGS, "\n"
-		"vector_complex_t___setitem__(vector_complex_t self, SWIGPY_SLICEOBJECT * slice, vector_complex_t v)\n"
-		"vector_complex_t___setitem__(vector_complex_t self, SWIGPY_SLICEOBJECT * slice)\n"
-		"vector_complex_t___setitem__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::value_type const & x)\n"
+	 { "vector_complex_T___setitem__", _wrap_vector_complex_T___setitem__, METH_VARARGS, "\n"
+		"vector_complex_T___setitem__(vector_complex_T self, SWIGPY_SLICEOBJECT * slice, vector_complex_T v)\n"
+		"vector_complex_T___setitem__(vector_complex_T self, SWIGPY_SLICEOBJECT * slice)\n"
+		"vector_complex_T___setitem__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::value_type const & x)\n"
 		""},
-	 { "vector_complex_t_pop", _wrap_vector_complex_t_pop, METH_O, "vector_complex_t_pop(vector_complex_t self) -> std::vector< std::complex< double > >::value_type"},
-	 { "vector_complex_t_append", _wrap_vector_complex_t_append, METH_VARARGS, "vector_complex_t_append(vector_complex_t self, std::vector< std::complex< double > >::value_type const & x)"},
-	 { "vector_complex_t_empty", _wrap_vector_complex_t_empty, METH_O, "vector_complex_t_empty(vector_complex_t self) -> bool"},
-	 { "vector_complex_t_size", _wrap_vector_complex_t_size, METH_O, "vector_complex_t_size(vector_complex_t self) -> std::vector< std::complex< double > >::size_type"},
-	 { "vector_complex_t_swap", _wrap_vector_complex_t_swap, METH_VARARGS, "vector_complex_t_swap(vector_complex_t self, vector_complex_t v)"},
-	 { "vector_complex_t_begin", _wrap_vector_complex_t_begin, METH_O, "vector_complex_t_begin(vector_complex_t self) -> std::vector< std::complex< double > >::iterator"},
-	 { "vector_complex_t_end", _wrap_vector_complex_t_end, METH_O, "vector_complex_t_end(vector_complex_t self) -> std::vector< std::complex< double > >::iterator"},
-	 { "vector_complex_t_rbegin", _wrap_vector_complex_t_rbegin, METH_O, "vector_complex_t_rbegin(vector_complex_t self) -> std::vector< std::complex< double > >::reverse_iterator"},
-	 { "vector_complex_t_rend", _wrap_vector_complex_t_rend, METH_O, "vector_complex_t_rend(vector_complex_t self) -> std::vector< std::complex< double > >::reverse_iterator"},
-	 { "vector_complex_t_clear", _wrap_vector_complex_t_clear, METH_O, "vector_complex_t_clear(vector_complex_t self)"},
-	 { "vector_complex_t_get_allocator", _wrap_vector_complex_t_get_allocator, METH_O, "vector_complex_t_get_allocator(vector_complex_t self) -> std::vector< std::complex< double > >::allocator_type"},
-	 { "vector_complex_t_pop_back", _wrap_vector_complex_t_pop_back, METH_O, "vector_complex_t_pop_back(vector_complex_t self)"},
-	 { "vector_complex_t_erase", _wrap_vector_complex_t_erase, METH_VARARGS, "\n"
-		"vector_complex_t_erase(vector_complex_t self, std::vector< std::complex< double > >::iterator pos) -> std::vector< std::complex< double > >::iterator\n"
-		"vector_complex_t_erase(vector_complex_t self, std::vector< std::complex< double > >::iterator first, std::vector< std::complex< double > >::iterator last) -> std::vector< std::complex< double > >::iterator\n"
+	 { "vector_complex_T_pop", _wrap_vector_complex_T_pop, METH_O, "vector_complex_T_pop(vector_complex_T self) -> std::vector< std::complex< double > >::value_type"},
+	 { "vector_complex_T_append", _wrap_vector_complex_T_append, METH_VARARGS, "vector_complex_T_append(vector_complex_T self, std::vector< std::complex< double > >::value_type const & x)"},
+	 { "vector_complex_T_empty", _wrap_vector_complex_T_empty, METH_O, "vector_complex_T_empty(vector_complex_T self) -> bool"},
+	 { "vector_complex_T_size", _wrap_vector_complex_T_size, METH_O, "vector_complex_T_size(vector_complex_T self) -> std::vector< std::complex< double > >::size_type"},
+	 { "vector_complex_T_swap", _wrap_vector_complex_T_swap, METH_VARARGS, "vector_complex_T_swap(vector_complex_T self, vector_complex_T v)"},
+	 { "vector_complex_T_begin", _wrap_vector_complex_T_begin, METH_O, "vector_complex_T_begin(vector_complex_T self) -> std::vector< std::complex< double > >::iterator"},
+	 { "vector_complex_T_end", _wrap_vector_complex_T_end, METH_O, "vector_complex_T_end(vector_complex_T self) -> std::vector< std::complex< double > >::iterator"},
+	 { "vector_complex_T_rbegin", _wrap_vector_complex_T_rbegin, METH_O, "vector_complex_T_rbegin(vector_complex_T self) -> std::vector< std::complex< double > >::reverse_iterator"},
+	 { "vector_complex_T_rend", _wrap_vector_complex_T_rend, METH_O, "vector_complex_T_rend(vector_complex_T self) -> std::vector< std::complex< double > >::reverse_iterator"},
+	 { "vector_complex_T_clear", _wrap_vector_complex_T_clear, METH_O, "vector_complex_T_clear(vector_complex_T self)"},
+	 { "vector_complex_T_get_allocator", _wrap_vector_complex_T_get_allocator, METH_O, "vector_complex_T_get_allocator(vector_complex_T self) -> std::vector< std::complex< double > >::allocator_type"},
+	 { "vector_complex_T_pop_back", _wrap_vector_complex_T_pop_back, METH_O, "vector_complex_T_pop_back(vector_complex_T self)"},
+	 { "vector_complex_T_erase", _wrap_vector_complex_T_erase, METH_VARARGS, "\n"
+		"vector_complex_T_erase(vector_complex_T self, std::vector< std::complex< double > >::iterator pos) -> std::vector< std::complex< double > >::iterator\n"
+		"vector_complex_T_erase(vector_complex_T self, std::vector< std::complex< double > >::iterator first, std::vector< std::complex< double > >::iterator last) -> std::vector< std::complex< double > >::iterator\n"
 		""},
-	 { "new_vector_complex_t", _wrap_new_vector_complex_t, METH_VARARGS, "\n"
-		"vector_complex_t()\n"
-		"vector_complex_t(vector_complex_t other)\n"
-		"vector_complex_t(std::vector< std::complex< double > >::size_type size)\n"
-		"new_vector_complex_t(std::vector< std::complex< double > >::size_type size, std::vector< std::complex< double > >::value_type const & value) -> vector_complex_t\n"
+	 { "new_vector_complex_T", _wrap_new_vector_complex_T, METH_VARARGS, "\n"
+		"vector_complex_T()\n"
+		"vector_complex_T(vector_complex_T other)\n"
+		"vector_complex_T(std::vector< std::complex< double > >::size_type size)\n"
+		"new_vector_complex_T(std::vector< std::complex< double > >::size_type size, std::vector< std::complex< double > >::value_type const & value) -> vector_complex_T\n"
 		""},
-	 { "vector_complex_t_push_back", _wrap_vector_complex_t_push_back, METH_VARARGS, "vector_complex_t_push_back(vector_complex_t self, std::vector< std::complex< double > >::value_type const & x)"},
-	 { "vector_complex_t_front", _wrap_vector_complex_t_front, METH_O, "vector_complex_t_front(vector_complex_t self) -> std::vector< std::complex< double > >::value_type const &"},
-	 { "vector_complex_t_back", _wrap_vector_complex_t_back, METH_O, "vector_complex_t_back(vector_complex_t self) -> std::vector< std::complex< double > >::value_type const &"},
-	 { "vector_complex_t_assign", _wrap_vector_complex_t_assign, METH_VARARGS, "vector_complex_t_assign(vector_complex_t self, std::vector< std::complex< double > >::size_type n, std::vector< std::complex< double > >::value_type const & x)"},
-	 { "vector_complex_t_resize", _wrap_vector_complex_t_resize, METH_VARARGS, "\n"
-		"vector_complex_t_resize(vector_complex_t self, std::vector< std::complex< double > >::size_type new_size)\n"
-		"vector_complex_t_resize(vector_complex_t self, std::vector< std::complex< double > >::size_type new_size, std::vector< std::complex< double > >::value_type const & x)\n"
+	 { "vector_complex_T_push_back", _wrap_vector_complex_T_push_back, METH_VARARGS, "vector_complex_T_push_back(vector_complex_T self, std::vector< std::complex< double > >::value_type const & x)"},
+	 { "vector_complex_T_front", _wrap_vector_complex_T_front, METH_O, "vector_complex_T_front(vector_complex_T self) -> std::vector< std::complex< double > >::value_type const &"},
+	 { "vector_complex_T_back", _wrap_vector_complex_T_back, METH_O, "vector_complex_T_back(vector_complex_T self) -> std::vector< std::complex< double > >::value_type const &"},
+	 { "vector_complex_T_assign", _wrap_vector_complex_T_assign, METH_VARARGS, "vector_complex_T_assign(vector_complex_T self, std::vector< std::complex< double > >::size_type n, std::vector< std::complex< double > >::value_type const & x)"},
+	 { "vector_complex_T_resize", _wrap_vector_complex_T_resize, METH_VARARGS, "\n"
+		"vector_complex_T_resize(vector_complex_T self, std::vector< std::complex< double > >::size_type new_size)\n"
+		"vector_complex_T_resize(vector_complex_T self, std::vector< std::complex< double > >::size_type new_size, std::vector< std::complex< double > >::value_type const & x)\n"
 		""},
-	 { "vector_complex_t_insert", _wrap_vector_complex_t_insert, METH_VARARGS, "\n"
-		"vector_complex_t_insert(vector_complex_t self, std::vector< std::complex< double > >::iterator pos, std::vector< std::complex< double > >::value_type const & x) -> std::vector< std::complex< double > >::iterator\n"
-		"vector_complex_t_insert(vector_complex_t self, std::vector< std::complex< double > >::iterator pos, std::vector< std::complex< double > >::size_type n, std::vector< std::complex< double > >::value_type const & x)\n"
+	 { "vector_complex_T_insert", _wrap_vector_complex_T_insert, METH_VARARGS, "\n"
+		"vector_complex_T_insert(vector_complex_T self, std::vector< std::complex< double > >::iterator pos, std::vector< std::complex< double > >::value_type const & x) -> std::vector< std::complex< double > >::iterator\n"
+		"vector_complex_T_insert(vector_complex_T self, std::vector< std::complex< double > >::iterator pos, std::vector< std::complex< double > >::size_type n, std::vector< std::complex< double > >::value_type const & x)\n"
 		""},
-	 { "vector_complex_t_reserve", _wrap_vector_complex_t_reserve, METH_VARARGS, "vector_complex_t_reserve(vector_complex_t self, std::vector< std::complex< double > >::size_type n)"},
-	 { "vector_complex_t_capacity", _wrap_vector_complex_t_capacity, METH_O, "vector_complex_t_capacity(vector_complex_t self) -> std::vector< std::complex< double > >::size_type"},
-	 { "delete_vector_complex_t", _wrap_delete_vector_complex_t, METH_O, "delete_vector_complex_t(vector_complex_t self)"},
-	 { "vector_complex_t_swigregister", vector_complex_t_swigregister, METH_O, NULL},
-	 { "vector_complex_t_swiginit", vector_complex_t_swiginit, METH_VARARGS, NULL},
-	 { "vector_string_t_iterator", _wrap_vector_string_t_iterator, METH_O, "vector_string_t_iterator(vector_string_t self) -> SwigPyIterator"},
-	 { "vector_string_t___nonzero__", _wrap_vector_string_t___nonzero__, METH_O, "vector_string_t___nonzero__(vector_string_t self) -> bool"},
-	 { "vector_string_t___bool__", _wrap_vector_string_t___bool__, METH_O, "vector_string_t___bool__(vector_string_t self) -> bool"},
-	 { "vector_string_t___len__", _wrap_vector_string_t___len__, METH_O, "vector_string_t___len__(vector_string_t self) -> std::vector< std::string >::size_type"},
-	 { "vector_string_t___getslice__", _wrap_vector_string_t___getslice__, METH_VARARGS, "vector_string_t___getslice__(vector_string_t self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j) -> vector_string_t"},
-	 { "vector_string_t___setslice__", _wrap_vector_string_t___setslice__, METH_VARARGS, "\n"
-		"vector_string_t___setslice__(vector_string_t self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j)\n"
-		"vector_string_t___setslice__(vector_string_t self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j, vector_string_t v)\n"
+	 { "vector_complex_T_reserve", _wrap_vector_complex_T_reserve, METH_VARARGS, "vector_complex_T_reserve(vector_complex_T self, std::vector< std::complex< double > >::size_type n)"},
+	 { "vector_complex_T_capacity", _wrap_vector_complex_T_capacity, METH_O, "vector_complex_T_capacity(vector_complex_T self) -> std::vector< std::complex< double > >::size_type"},
+	 { "delete_vector_complex_T", _wrap_delete_vector_complex_T, METH_O, "delete_vector_complex_T(vector_complex_T self)"},
+	 { "vector_complex_T_swigregister", vector_complex_T_swigregister, METH_O, NULL},
+	 { "vector_complex_T_swiginit", vector_complex_T_swiginit, METH_VARARGS, NULL},
+	 { "vector_string_T_iterator", _wrap_vector_string_T_iterator, METH_O, "vector_string_T_iterator(vector_string_T self) -> SwigPyIterator"},
+	 { "vector_string_T___nonzero__", _wrap_vector_string_T___nonzero__, METH_O, "vector_string_T___nonzero__(vector_string_T self) -> bool"},
+	 { "vector_string_T___bool__", _wrap_vector_string_T___bool__, METH_O, "vector_string_T___bool__(vector_string_T self) -> bool"},
+	 { "vector_string_T___len__", _wrap_vector_string_T___len__, METH_O, "vector_string_T___len__(vector_string_T self) -> std::vector< std::string >::size_type"},
+	 { "vector_string_T___getslice__", _wrap_vector_string_T___getslice__, METH_VARARGS, "vector_string_T___getslice__(vector_string_T self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j) -> vector_string_T"},
+	 { "vector_string_T___setslice__", _wrap_vector_string_T___setslice__, METH_VARARGS, "\n"
+		"vector_string_T___setslice__(vector_string_T self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j)\n"
+		"vector_string_T___setslice__(vector_string_T self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j, vector_string_T v)\n"
 		""},
-	 { "vector_string_t___delslice__", _wrap_vector_string_t___delslice__, METH_VARARGS, "vector_string_t___delslice__(vector_string_t self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j)"},
-	 { "vector_string_t___delitem__", _wrap_vector_string_t___delitem__, METH_VARARGS, "\n"
-		"vector_string_t___delitem__(vector_string_t self, std::vector< std::string >::difference_type i)\n"
-		"vector_string_t___delitem__(vector_string_t self, SWIGPY_SLICEOBJECT * slice)\n"
+	 { "vector_string_T___delslice__", _wrap_vector_string_T___delslice__, METH_VARARGS, "vector_string_T___delslice__(vector_string_T self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j)"},
+	 { "vector_string_T___delitem__", _wrap_vector_string_T___delitem__, METH_VARARGS, "\n"
+		"vector_string_T___delitem__(vector_string_T self, std::vector< std::string >::difference_type i)\n"
+		"vector_string_T___delitem__(vector_string_T self, SWIGPY_SLICEOBJECT * slice)\n"
 		""},
-	 { "vector_string_t___getitem__", _wrap_vector_string_t___getitem__, METH_VARARGS, "\n"
-		"vector_string_t___getitem__(vector_string_t self, SWIGPY_SLICEOBJECT * slice) -> vector_string_t\n"
-		"vector_string_t___getitem__(vector_string_t self, std::vector< std::string >::difference_type i) -> std::vector< std::string >::value_type const &\n"
+	 { "vector_string_T___getitem__", _wrap_vector_string_T___getitem__, METH_VARARGS, "\n"
+		"vector_string_T___getitem__(vector_string_T self, SWIGPY_SLICEOBJECT * slice) -> vector_string_T\n"
+		"vector_string_T___getitem__(vector_string_T self, std::vector< std::string >::difference_type i) -> std::vector< std::string >::value_type const &\n"
 		""},
-	 { "vector_string_t___setitem__", _wrap_vector_string_t___setitem__, METH_VARARGS, "\n"
-		"vector_string_t___setitem__(vector_string_t self, SWIGPY_SLICEOBJECT * slice, vector_string_t v)\n"
-		"vector_string_t___setitem__(vector_string_t self, SWIGPY_SLICEOBJECT * slice)\n"
-		"vector_string_t___setitem__(vector_string_t self, std::vector< std::string >::difference_type i, std::vector< std::string >::value_type const & x)\n"
+	 { "vector_string_T___setitem__", _wrap_vector_string_T___setitem__, METH_VARARGS, "\n"
+		"vector_string_T___setitem__(vector_string_T self, SWIGPY_SLICEOBJECT * slice, vector_string_T v)\n"
+		"vector_string_T___setitem__(vector_string_T self, SWIGPY_SLICEOBJECT * slice)\n"
+		"vector_string_T___setitem__(vector_string_T self, std::vector< std::string >::difference_type i, std::vector< std::string >::value_type const & x)\n"
 		""},
-	 { "vector_string_t_pop", _wrap_vector_string_t_pop, METH_O, "vector_string_t_pop(vector_string_t self) -> std::vector< std::string >::value_type"},
-	 { "vector_string_t_append", _wrap_vector_string_t_append, METH_VARARGS, "vector_string_t_append(vector_string_t self, std::vector< std::string >::value_type const & x)"},
-	 { "vector_string_t_empty", _wrap_vector_string_t_empty, METH_O, "vector_string_t_empty(vector_string_t self) -> bool"},
-	 { "vector_string_t_size", _wrap_vector_string_t_size, METH_O, "vector_string_t_size(vector_string_t self) -> std::vector< std::string >::size_type"},
-	 { "vector_string_t_swap", _wrap_vector_string_t_swap, METH_VARARGS, "vector_string_t_swap(vector_string_t self, vector_string_t v)"},
-	 { "vector_string_t_begin", _wrap_vector_string_t_begin, METH_O, "vector_string_t_begin(vector_string_t self) -> std::vector< std::string >::iterator"},
-	 { "vector_string_t_end", _wrap_vector_string_t_end, METH_O, "vector_string_t_end(vector_string_t self) -> std::vector< std::string >::iterator"},
-	 { "vector_string_t_rbegin", _wrap_vector_string_t_rbegin, METH_O, "vector_string_t_rbegin(vector_string_t self) -> std::vector< std::string >::reverse_iterator"},
-	 { "vector_string_t_rend", _wrap_vector_string_t_rend, METH_O, "vector_string_t_rend(vector_string_t self) -> std::vector< std::string >::reverse_iterator"},
-	 { "vector_string_t_clear", _wrap_vector_string_t_clear, METH_O, "vector_string_t_clear(vector_string_t self)"},
-	 { "vector_string_t_get_allocator", _wrap_vector_string_t_get_allocator, METH_O, "vector_string_t_get_allocator(vector_string_t self) -> std::vector< std::string >::allocator_type"},
-	 { "vector_string_t_pop_back", _wrap_vector_string_t_pop_back, METH_O, "vector_string_t_pop_back(vector_string_t self)"},
-	 { "vector_string_t_erase", _wrap_vector_string_t_erase, METH_VARARGS, "\n"
-		"vector_string_t_erase(vector_string_t self, std::vector< std::string >::iterator pos) -> std::vector< std::string >::iterator\n"
-		"vector_string_t_erase(vector_string_t self, std::vector< std::string >::iterator first, std::vector< std::string >::iterator last) -> std::vector< std::string >::iterator\n"
+	 { "vector_string_T_pop", _wrap_vector_string_T_pop, METH_O, "vector_string_T_pop(vector_string_T self) -> std::vector< std::string >::value_type"},
+	 { "vector_string_T_append", _wrap_vector_string_T_append, METH_VARARGS, "vector_string_T_append(vector_string_T self, std::vector< std::string >::value_type const & x)"},
+	 { "vector_string_T_empty", _wrap_vector_string_T_empty, METH_O, "vector_string_T_empty(vector_string_T self) -> bool"},
+	 { "vector_string_T_size", _wrap_vector_string_T_size, METH_O, "vector_string_T_size(vector_string_T self) -> std::vector< std::string >::size_type"},
+	 { "vector_string_T_swap", _wrap_vector_string_T_swap, METH_VARARGS, "vector_string_T_swap(vector_string_T self, vector_string_T v)"},
+	 { "vector_string_T_begin", _wrap_vector_string_T_begin, METH_O, "vector_string_T_begin(vector_string_T self) -> std::vector< std::string >::iterator"},
+	 { "vector_string_T_end", _wrap_vector_string_T_end, METH_O, "vector_string_T_end(vector_string_T self) -> std::vector< std::string >::iterator"},
+	 { "vector_string_T_rbegin", _wrap_vector_string_T_rbegin, METH_O, "vector_string_T_rbegin(vector_string_T self) -> std::vector< std::string >::reverse_iterator"},
+	 { "vector_string_T_rend", _wrap_vector_string_T_rend, METH_O, "vector_string_T_rend(vector_string_T self) -> std::vector< std::string >::reverse_iterator"},
+	 { "vector_string_T_clear", _wrap_vector_string_T_clear, METH_O, "vector_string_T_clear(vector_string_T self)"},
+	 { "vector_string_T_get_allocator", _wrap_vector_string_T_get_allocator, METH_O, "vector_string_T_get_allocator(vector_string_T self) -> std::vector< std::string >::allocator_type"},
+	 { "vector_string_T_pop_back", _wrap_vector_string_T_pop_back, METH_O, "vector_string_T_pop_back(vector_string_T self)"},
+	 { "vector_string_T_erase", _wrap_vector_string_T_erase, METH_VARARGS, "\n"
+		"vector_string_T_erase(vector_string_T self, std::vector< std::string >::iterator pos) -> std::vector< std::string >::iterator\n"
+		"vector_string_T_erase(vector_string_T self, std::vector< std::string >::iterator first, std::vector< std::string >::iterator last) -> std::vector< std::string >::iterator\n"
 		""},
-	 { "new_vector_string_t", _wrap_new_vector_string_t, METH_VARARGS, "\n"
-		"vector_string_t()\n"
-		"vector_string_t(vector_string_t other)\n"
-		"vector_string_t(std::vector< std::string >::size_type size)\n"
-		"new_vector_string_t(std::vector< std::string >::size_type size, std::vector< std::string >::value_type const & value) -> vector_string_t\n"
+	 { "new_vector_string_T", _wrap_new_vector_string_T, METH_VARARGS, "\n"
+		"vector_string_T()\n"
+		"vector_string_T(vector_string_T other)\n"
+		"vector_string_T(std::vector< std::string >::size_type size)\n"
+		"new_vector_string_T(std::vector< std::string >::size_type size, std::vector< std::string >::value_type const & value) -> vector_string_T\n"
 		""},
-	 { "vector_string_t_push_back", _wrap_vector_string_t_push_back, METH_VARARGS, "vector_string_t_push_back(vector_string_t self, std::vector< std::string >::value_type const & x)"},
-	 { "vector_string_t_front", _wrap_vector_string_t_front, METH_O, "vector_string_t_front(vector_string_t self) -> std::vector< std::string >::value_type const &"},
-	 { "vector_string_t_back", _wrap_vector_string_t_back, METH_O, "vector_string_t_back(vector_string_t self) -> std::vector< std::string >::value_type const &"},
-	 { "vector_string_t_assign", _wrap_vector_string_t_assign, METH_VARARGS, "vector_string_t_assign(vector_string_t self, std::vector< std::string >::size_type n, std::vector< std::string >::value_type const & x)"},
-	 { "vector_string_t_resize", _wrap_vector_string_t_resize, METH_VARARGS, "\n"
-		"vector_string_t_resize(vector_string_t self, std::vector< std::string >::size_type new_size)\n"
-		"vector_string_t_resize(vector_string_t self, std::vector< std::string >::size_type new_size, std::vector< std::string >::value_type const & x)\n"
+	 { "vector_string_T_push_back", _wrap_vector_string_T_push_back, METH_VARARGS, "vector_string_T_push_back(vector_string_T self, std::vector< std::string >::value_type const & x)"},
+	 { "vector_string_T_front", _wrap_vector_string_T_front, METH_O, "vector_string_T_front(vector_string_T self) -> std::vector< std::string >::value_type const &"},
+	 { "vector_string_T_back", _wrap_vector_string_T_back, METH_O, "vector_string_T_back(vector_string_T self) -> std::vector< std::string >::value_type const &"},
+	 { "vector_string_T_assign", _wrap_vector_string_T_assign, METH_VARARGS, "vector_string_T_assign(vector_string_T self, std::vector< std::string >::size_type n, std::vector< std::string >::value_type const & x)"},
+	 { "vector_string_T_resize", _wrap_vector_string_T_resize, METH_VARARGS, "\n"
+		"vector_string_T_resize(vector_string_T self, std::vector< std::string >::size_type new_size)\n"
+		"vector_string_T_resize(vector_string_T self, std::vector< std::string >::size_type new_size, std::vector< std::string >::value_type const & x)\n"
 		""},
-	 { "vector_string_t_insert", _wrap_vector_string_t_insert, METH_VARARGS, "\n"
-		"vector_string_t_insert(vector_string_t self, std::vector< std::string >::iterator pos, std::vector< std::string >::value_type const & x) -> std::vector< std::string >::iterator\n"
-		"vector_string_t_insert(vector_string_t self, std::vector< std::string >::iterator pos, std::vector< std::string >::size_type n, std::vector< std::string >::value_type const & x)\n"
+	 { "vector_string_T_insert", _wrap_vector_string_T_insert, METH_VARARGS, "\n"
+		"vector_string_T_insert(vector_string_T self, std::vector< std::string >::iterator pos, std::vector< std::string >::value_type const & x) -> std::vector< std::string >::iterator\n"
+		"vector_string_T_insert(vector_string_T self, std::vector< std::string >::iterator pos, std::vector< std::string >::size_type n, std::vector< std::string >::value_type const & x)\n"
 		""},
-	 { "vector_string_t_reserve", _wrap_vector_string_t_reserve, METH_VARARGS, "vector_string_t_reserve(vector_string_t self, std::vector< std::string >::size_type n)"},
-	 { "vector_string_t_capacity", _wrap_vector_string_t_capacity, METH_O, "vector_string_t_capacity(vector_string_t self) -> std::vector< std::string >::size_type"},
-	 { "delete_vector_string_t", _wrap_delete_vector_string_t, METH_O, "delete_vector_string_t(vector_string_t self)"},
-	 { "vector_string_t_swigregister", vector_string_t_swigregister, METH_O, NULL},
-	 { "vector_string_t_swiginit", vector_string_t_swiginit, METH_VARARGS, NULL},
-	 { "map_string_double_t_iterator", _wrap_map_string_double_t_iterator, METH_O, "map_string_double_t_iterator(map_string_double_t self) -> SwigPyIterator"},
-	 { "map_string_double_t___nonzero__", _wrap_map_string_double_t___nonzero__, METH_O, "map_string_double_t___nonzero__(map_string_double_t self) -> bool"},
-	 { "map_string_double_t___bool__", _wrap_map_string_double_t___bool__, METH_O, "map_string_double_t___bool__(map_string_double_t self) -> bool"},
-	 { "map_string_double_t___len__", _wrap_map_string_double_t___len__, METH_O, "map_string_double_t___len__(map_string_double_t self) -> std::map< std::string,double >::size_type"},
-	 { "map_string_double_t___getitem__", _wrap_map_string_double_t___getitem__, METH_VARARGS, "map_string_double_t___getitem__(map_string_double_t self, std::map< std::string,double >::key_type const & key) -> std::map< std::string,double >::mapped_type const &"},
-	 { "map_string_double_t___delitem__", _wrap_map_string_double_t___delitem__, METH_VARARGS, "map_string_double_t___delitem__(map_string_double_t self, std::map< std::string,double >::key_type const & key)"},
-	 { "map_string_double_t_has_key", _wrap_map_string_double_t_has_key, METH_VARARGS, "map_string_double_t_has_key(map_string_double_t self, std::map< std::string,double >::key_type const & key) -> bool"},
-	 { "map_string_double_t_keys", _wrap_map_string_double_t_keys, METH_O, "map_string_double_t_keys(map_string_double_t self) -> PyObject *"},
-	 { "map_string_double_t_values", _wrap_map_string_double_t_values, METH_O, "map_string_double_t_values(map_string_double_t self) -> PyObject *"},
-	 { "map_string_double_t_items", _wrap_map_string_double_t_items, METH_O, "map_string_double_t_items(map_string_double_t self) -> PyObject *"},
-	 { "map_string_double_t___contains__", _wrap_map_string_double_t___contains__, METH_VARARGS, "map_string_double_t___contains__(map_string_double_t self, std::map< std::string,double >::key_type const & key) -> bool"},
-	 { "map_string_double_t_key_iterator", _wrap_map_string_double_t_key_iterator, METH_O, "map_string_double_t_key_iterator(map_string_double_t self) -> SwigPyIterator"},
-	 { "map_string_double_t_value_iterator", _wrap_map_string_double_t_value_iterator, METH_O, "map_string_double_t_value_iterator(map_string_double_t self) -> SwigPyIterator"},
-	 { "map_string_double_t___setitem__", _wrap_map_string_double_t___setitem__, METH_VARARGS, "\n"
-		"map_string_double_t___setitem__(map_string_double_t self, std::map< std::string,double >::key_type const & key)\n"
-		"map_string_double_t___setitem__(map_string_double_t self, std::map< std::string,double >::key_type const & key, std::map< std::string,double >::mapped_type const & x)\n"
+	 { "vector_string_T_reserve", _wrap_vector_string_T_reserve, METH_VARARGS, "vector_string_T_reserve(vector_string_T self, std::vector< std::string >::size_type n)"},
+	 { "vector_string_T_capacity", _wrap_vector_string_T_capacity, METH_O, "vector_string_T_capacity(vector_string_T self) -> std::vector< std::string >::size_type"},
+	 { "delete_vector_string_T", _wrap_delete_vector_string_T, METH_O, "delete_vector_string_T(vector_string_T self)"},
+	 { "vector_string_T_swigregister", vector_string_T_swigregister, METH_O, NULL},
+	 { "vector_string_T_swiginit", vector_string_T_swiginit, METH_VARARGS, NULL},
+	 { "map_string_double_T_iterator", _wrap_map_string_double_T_iterator, METH_O, "map_string_double_T_iterator(map_string_double_T self) -> SwigPyIterator"},
+	 { "map_string_double_T___nonzero__", _wrap_map_string_double_T___nonzero__, METH_O, "map_string_double_T___nonzero__(map_string_double_T self) -> bool"},
+	 { "map_string_double_T___bool__", _wrap_map_string_double_T___bool__, METH_O, "map_string_double_T___bool__(map_string_double_T self) -> bool"},
+	 { "map_string_double_T___len__", _wrap_map_string_double_T___len__, METH_O, "map_string_double_T___len__(map_string_double_T self) -> std::map< std::string,double >::size_type"},
+	 { "map_string_double_T___getitem__", _wrap_map_string_double_T___getitem__, METH_VARARGS, "map_string_double_T___getitem__(map_string_double_T self, std::map< std::string,double >::key_type const & key) -> std::map< std::string,double >::mapped_type const &"},
+	 { "map_string_double_T___delitem__", _wrap_map_string_double_T___delitem__, METH_VARARGS, "map_string_double_T___delitem__(map_string_double_T self, std::map< std::string,double >::key_type const & key)"},
+	 { "map_string_double_T_has_key", _wrap_map_string_double_T_has_key, METH_VARARGS, "map_string_double_T_has_key(map_string_double_T self, std::map< std::string,double >::key_type const & key) -> bool"},
+	 { "map_string_double_T_keys", _wrap_map_string_double_T_keys, METH_O, "map_string_double_T_keys(map_string_double_T self) -> PyObject *"},
+	 { "map_string_double_T_values", _wrap_map_string_double_T_values, METH_O, "map_string_double_T_values(map_string_double_T self) -> PyObject *"},
+	 { "map_string_double_T_items", _wrap_map_string_double_T_items, METH_O, "map_string_double_T_items(map_string_double_T self) -> PyObject *"},
+	 { "map_string_double_T___contains__", _wrap_map_string_double_T___contains__, METH_VARARGS, "map_string_double_T___contains__(map_string_double_T self, std::map< std::string,double >::key_type const & key) -> bool"},
+	 { "map_string_double_T_key_iterator", _wrap_map_string_double_T_key_iterator, METH_O, "map_string_double_T_key_iterator(map_string_double_T self) -> SwigPyIterator"},
+	 { "map_string_double_T_value_iterator", _wrap_map_string_double_T_value_iterator, METH_O, "map_string_double_T_value_iterator(map_string_double_T self) -> SwigPyIterator"},
+	 { "map_string_double_T___setitem__", _wrap_map_string_double_T___setitem__, METH_VARARGS, "\n"
+		"map_string_double_T___setitem__(map_string_double_T self, std::map< std::string,double >::key_type const & key)\n"
+		"map_string_double_T___setitem__(map_string_double_T self, std::map< std::string,double >::key_type const & key, std::map< std::string,double >::mapped_type const & x)\n"
 		""},
-	 { "map_string_double_t_asdict", _wrap_map_string_double_t_asdict, METH_O, "map_string_double_t_asdict(map_string_double_t self) -> PyObject *"},
-	 { "new_map_string_double_t", _wrap_new_map_string_double_t, METH_VARARGS, "\n"
-		"map_string_double_t(std::less< std::string > const & other)\n"
-		"map_string_double_t()\n"
-		"new_map_string_double_t(map_string_double_t other) -> map_string_double_t\n"
+	 { "map_string_double_T_asdict", _wrap_map_string_double_T_asdict, METH_O, "map_string_double_T_asdict(map_string_double_T self) -> PyObject *"},
+	 { "new_map_string_double_T", _wrap_new_map_string_double_T, METH_VARARGS, "\n"
+		"map_string_double_T(std::less< std::string > const & other)\n"
+		"map_string_double_T()\n"
+		"new_map_string_double_T(map_string_double_T other) -> map_string_double_T\n"
 		""},
-	 { "map_string_double_t_empty", _wrap_map_string_double_t_empty, METH_O, "map_string_double_t_empty(map_string_double_t self) -> bool"},
-	 { "map_string_double_t_size", _wrap_map_string_double_t_size, METH_O, "map_string_double_t_size(map_string_double_t self) -> std::map< std::string,double >::size_type"},
-	 { "map_string_double_t_swap", _wrap_map_string_double_t_swap, METH_VARARGS, "map_string_double_t_swap(map_string_double_t self, map_string_double_t v)"},
-	 { "map_string_double_t_begin", _wrap_map_string_double_t_begin, METH_O, "map_string_double_t_begin(map_string_double_t self) -> std::map< std::string,double >::iterator"},
-	 { "map_string_double_t_end", _wrap_map_string_double_t_end, METH_O, "map_string_double_t_end(map_string_double_t self) -> std::map< std::string,double >::iterator"},
-	 { "map_string_double_t_rbegin", _wrap_map_string_double_t_rbegin, METH_O, "map_string_double_t_rbegin(map_string_double_t self) -> std::map< std::string,double >::reverse_iterator"},
-	 { "map_string_double_t_rend", _wrap_map_string_double_t_rend, METH_O, "map_string_double_t_rend(map_string_double_t self) -> std::map< std::string,double >::reverse_iterator"},
-	 { "map_string_double_t_clear", _wrap_map_string_double_t_clear, METH_O, "map_string_double_t_clear(map_string_double_t self)"},
-	 { "map_string_double_t_get_allocator", _wrap_map_string_double_t_get_allocator, METH_O, "map_string_double_t_get_allocator(map_string_double_t self) -> std::map< std::string,double >::allocator_type"},
-	 { "map_string_double_t_count", _wrap_map_string_double_t_count, METH_VARARGS, "map_string_double_t_count(map_string_double_t self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::size_type"},
-	 { "map_string_double_t_erase", _wrap_map_string_double_t_erase, METH_VARARGS, "\n"
-		"map_string_double_t_erase(map_string_double_t self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::size_type\n"
-		"map_string_double_t_erase(map_string_double_t self, std::map< std::string,double >::iterator position)\n"
-		"map_string_double_t_erase(map_string_double_t self, std::map< std::string,double >::iterator first, std::map< std::string,double >::iterator last)\n"
+	 { "map_string_double_T_empty", _wrap_map_string_double_T_empty, METH_O, "map_string_double_T_empty(map_string_double_T self) -> bool"},
+	 { "map_string_double_T_size", _wrap_map_string_double_T_size, METH_O, "map_string_double_T_size(map_string_double_T self) -> std::map< std::string,double >::size_type"},
+	 { "map_string_double_T_swap", _wrap_map_string_double_T_swap, METH_VARARGS, "map_string_double_T_swap(map_string_double_T self, map_string_double_T v)"},
+	 { "map_string_double_T_begin", _wrap_map_string_double_T_begin, METH_O, "map_string_double_T_begin(map_string_double_T self) -> std::map< std::string,double >::iterator"},
+	 { "map_string_double_T_end", _wrap_map_string_double_T_end, METH_O, "map_string_double_T_end(map_string_double_T self) -> std::map< std::string,double >::iterator"},
+	 { "map_string_double_T_rbegin", _wrap_map_string_double_T_rbegin, METH_O, "map_string_double_T_rbegin(map_string_double_T self) -> std::map< std::string,double >::reverse_iterator"},
+	 { "map_string_double_T_rend", _wrap_map_string_double_T_rend, METH_O, "map_string_double_T_rend(map_string_double_T self) -> std::map< std::string,double >::reverse_iterator"},
+	 { "map_string_double_T_clear", _wrap_map_string_double_T_clear, METH_O, "map_string_double_T_clear(map_string_double_T self)"},
+	 { "map_string_double_T_get_allocator", _wrap_map_string_double_T_get_allocator, METH_O, "map_string_double_T_get_allocator(map_string_double_T self) -> std::map< std::string,double >::allocator_type"},
+	 { "map_string_double_T_count", _wrap_map_string_double_T_count, METH_VARARGS, "map_string_double_T_count(map_string_double_T self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::size_type"},
+	 { "map_string_double_T_erase", _wrap_map_string_double_T_erase, METH_VARARGS, "\n"
+		"map_string_double_T_erase(map_string_double_T self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::size_type\n"
+		"map_string_double_T_erase(map_string_double_T self, std::map< std::string,double >::iterator position)\n"
+		"map_string_double_T_erase(map_string_double_T self, std::map< std::string,double >::iterator first, std::map< std::string,double >::iterator last)\n"
 		""},
-	 { "map_string_double_t_find", _wrap_map_string_double_t_find, METH_VARARGS, "map_string_double_t_find(map_string_double_t self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"},
-	 { "map_string_double_t_lower_bound", _wrap_map_string_double_t_lower_bound, METH_VARARGS, "map_string_double_t_lower_bound(map_string_double_t self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"},
-	 { "map_string_double_t_upper_bound", _wrap_map_string_double_t_upper_bound, METH_VARARGS, "map_string_double_t_upper_bound(map_string_double_t self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"},
-	 { "delete_map_string_double_t", _wrap_delete_map_string_double_t, METH_O, "delete_map_string_double_t(map_string_double_t self)"},
-	 { "map_string_double_t_swigregister", map_string_double_t_swigregister, METH_O, NULL},
-	 { "map_string_double_t_swiginit", map_string_double_t_swiginit, METH_VARARGS, NULL},
-	 { "new_pvacuum_double_t", _wrap_new_pvacuum_double_t, METH_VARARGS, "\n"
-		"pvacuum_double_t()\n"
-		"pvacuum_double_t(double first, double second)\n"
-		"new_pvacuum_double_t(pvacuum_double_t other) -> pvacuum_double_t\n"
+	 { "map_string_double_T_find", _wrap_map_string_double_T_find, METH_VARARGS, "map_string_double_T_find(map_string_double_T self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"},
+	 { "map_string_double_T_lower_bound", _wrap_map_string_double_T_lower_bound, METH_VARARGS, "map_string_double_T_lower_bound(map_string_double_T self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"},
+	 { "map_string_double_T_upper_bound", _wrap_map_string_double_T_upper_bound, METH_VARARGS, "map_string_double_T_upper_bound(map_string_double_T self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"},
+	 { "delete_map_string_double_T", _wrap_delete_map_string_double_T, METH_O, "delete_map_string_double_T(map_string_double_T self)"},
+	 { "map_string_double_T_swigregister", map_string_double_T_swigregister, METH_O, NULL},
+	 { "map_string_double_T_swiginit", map_string_double_T_swiginit, METH_VARARGS, NULL},
+	 { "new_pvacuum_double_T", _wrap_new_pvacuum_double_T, METH_VARARGS, "\n"
+		"pvacuum_double_T()\n"
+		"pvacuum_double_T(double first, double second)\n"
+		"new_pvacuum_double_T(pvacuum_double_T other) -> pvacuum_double_T\n"
 		""},
-	 { "pvacuum_double_t_first_set", _wrap_pvacuum_double_t_first_set, METH_VARARGS, "pvacuum_double_t_first_set(pvacuum_double_t self, double first)"},
-	 { "pvacuum_double_t_first_get", _wrap_pvacuum_double_t_first_get, METH_O, "pvacuum_double_t_first_get(pvacuum_double_t self) -> double"},
-	 { "pvacuum_double_t_second_set", _wrap_pvacuum_double_t_second_set, METH_VARARGS, "pvacuum_double_t_second_set(pvacuum_double_t self, double second)"},
-	 { "pvacuum_double_t_second_get", _wrap_pvacuum_double_t_second_get, METH_O, "pvacuum_double_t_second_get(pvacuum_double_t self) -> double"},
-	 { "delete_pvacuum_double_t", _wrap_delete_pvacuum_double_t, METH_O, "delete_pvacuum_double_t(pvacuum_double_t self)"},
-	 { "pvacuum_double_t_swigregister", pvacuum_double_t_swigregister, METH_O, NULL},
-	 { "pvacuum_double_t_swiginit", pvacuum_double_t_swiginit, METH_VARARGS, NULL},
-	 { "vector_pvacuum_double_t_iterator", _wrap_vector_pvacuum_double_t_iterator, METH_O, "vector_pvacuum_double_t_iterator(vector_pvacuum_double_t self) -> SwigPyIterator"},
-	 { "vector_pvacuum_double_t___nonzero__", _wrap_vector_pvacuum_double_t___nonzero__, METH_O, "vector_pvacuum_double_t___nonzero__(vector_pvacuum_double_t self) -> bool"},
-	 { "vector_pvacuum_double_t___bool__", _wrap_vector_pvacuum_double_t___bool__, METH_O, "vector_pvacuum_double_t___bool__(vector_pvacuum_double_t self) -> bool"},
-	 { "vector_pvacuum_double_t___len__", _wrap_vector_pvacuum_double_t___len__, METH_O, "vector_pvacuum_double_t___len__(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::size_type"},
-	 { "vector_pvacuum_double_t___getslice__", _wrap_vector_pvacuum_double_t___getslice__, METH_VARARGS, "vector_pvacuum_double_t___getslice__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j) -> vector_pvacuum_double_t"},
-	 { "vector_pvacuum_double_t___setslice__", _wrap_vector_pvacuum_double_t___setslice__, METH_VARARGS, "\n"
-		"vector_pvacuum_double_t___setslice__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j)\n"
-		"vector_pvacuum_double_t___setslice__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j, vector_pvacuum_double_t v)\n"
+	 { "pvacuum_double_T_first_set", _wrap_pvacuum_double_T_first_set, METH_VARARGS, "pvacuum_double_T_first_set(pvacuum_double_T self, double first)"},
+	 { "pvacuum_double_T_first_get", _wrap_pvacuum_double_T_first_get, METH_O, "pvacuum_double_T_first_get(pvacuum_double_T self) -> double"},
+	 { "pvacuum_double_T_second_set", _wrap_pvacuum_double_T_second_set, METH_VARARGS, "pvacuum_double_T_second_set(pvacuum_double_T self, double second)"},
+	 { "pvacuum_double_T_second_get", _wrap_pvacuum_double_T_second_get, METH_O, "pvacuum_double_T_second_get(pvacuum_double_T self) -> double"},
+	 { "delete_pvacuum_double_T", _wrap_delete_pvacuum_double_T, METH_O, "delete_pvacuum_double_T(pvacuum_double_T self)"},
+	 { "pvacuum_double_T_swigregister", pvacuum_double_T_swigregister, METH_O, NULL},
+	 { "pvacuum_double_T_swiginit", pvacuum_double_T_swiginit, METH_VARARGS, NULL},
+	 { "vector_pvacuum_double_T_iterator", _wrap_vector_pvacuum_double_T_iterator, METH_O, "vector_pvacuum_double_T_iterator(vector_pvacuum_double_T self) -> SwigPyIterator"},
+	 { "vector_pvacuum_double_T___nonzero__", _wrap_vector_pvacuum_double_T___nonzero__, METH_O, "vector_pvacuum_double_T___nonzero__(vector_pvacuum_double_T self) -> bool"},
+	 { "vector_pvacuum_double_T___bool__", _wrap_vector_pvacuum_double_T___bool__, METH_O, "vector_pvacuum_double_T___bool__(vector_pvacuum_double_T self) -> bool"},
+	 { "vector_pvacuum_double_T___len__", _wrap_vector_pvacuum_double_T___len__, METH_O, "vector_pvacuum_double_T___len__(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::size_type"},
+	 { "vector_pvacuum_double_T___getslice__", _wrap_vector_pvacuum_double_T___getslice__, METH_VARARGS, "vector_pvacuum_double_T___getslice__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j) -> vector_pvacuum_double_T"},
+	 { "vector_pvacuum_double_T___setslice__", _wrap_vector_pvacuum_double_T___setslice__, METH_VARARGS, "\n"
+		"vector_pvacuum_double_T___setslice__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j)\n"
+		"vector_pvacuum_double_T___setslice__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j, vector_pvacuum_double_T v)\n"
 		""},
-	 { "vector_pvacuum_double_t___delslice__", _wrap_vector_pvacuum_double_t___delslice__, METH_VARARGS, "vector_pvacuum_double_t___delslice__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j)"},
-	 { "vector_pvacuum_double_t___delitem__", _wrap_vector_pvacuum_double_t___delitem__, METH_VARARGS, "\n"
-		"vector_pvacuum_double_t___delitem__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i)\n"
-		"vector_pvacuum_double_t___delitem__(vector_pvacuum_double_t self, SWIGPY_SLICEOBJECT * slice)\n"
+	 { "vector_pvacuum_double_T___delslice__", _wrap_vector_pvacuum_double_T___delslice__, METH_VARARGS, "vector_pvacuum_double_T___delslice__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j)"},
+	 { "vector_pvacuum_double_T___delitem__", _wrap_vector_pvacuum_double_T___delitem__, METH_VARARGS, "\n"
+		"vector_pvacuum_double_T___delitem__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i)\n"
+		"vector_pvacuum_double_T___delitem__(vector_pvacuum_double_T self, SWIGPY_SLICEOBJECT * slice)\n"
 		""},
-	 { "vector_pvacuum_double_t___getitem__", _wrap_vector_pvacuum_double_t___getitem__, METH_VARARGS, "\n"
-		"vector_pvacuum_double_t___getitem__(vector_pvacuum_double_t self, SWIGPY_SLICEOBJECT * slice) -> vector_pvacuum_double_t\n"
-		"vector_pvacuum_double_t___getitem__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i) -> pvacuum_double_t\n"
+	 { "vector_pvacuum_double_T___getitem__", _wrap_vector_pvacuum_double_T___getitem__, METH_VARARGS, "\n"
+		"vector_pvacuum_double_T___getitem__(vector_pvacuum_double_T self, SWIGPY_SLICEOBJECT * slice) -> vector_pvacuum_double_T\n"
+		"vector_pvacuum_double_T___getitem__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i) -> pvacuum_double_T\n"
 		""},
-	 { "vector_pvacuum_double_t___setitem__", _wrap_vector_pvacuum_double_t___setitem__, METH_VARARGS, "\n"
-		"vector_pvacuum_double_t___setitem__(vector_pvacuum_double_t self, SWIGPY_SLICEOBJECT * slice, vector_pvacuum_double_t v)\n"
-		"vector_pvacuum_double_t___setitem__(vector_pvacuum_double_t self, SWIGPY_SLICEOBJECT * slice)\n"
-		"vector_pvacuum_double_t___setitem__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i, pvacuum_double_t x)\n"
+	 { "vector_pvacuum_double_T___setitem__", _wrap_vector_pvacuum_double_T___setitem__, METH_VARARGS, "\n"
+		"vector_pvacuum_double_T___setitem__(vector_pvacuum_double_T self, SWIGPY_SLICEOBJECT * slice, vector_pvacuum_double_T v)\n"
+		"vector_pvacuum_double_T___setitem__(vector_pvacuum_double_T self, SWIGPY_SLICEOBJECT * slice)\n"
+		"vector_pvacuum_double_T___setitem__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i, pvacuum_double_T x)\n"
 		""},
-	 { "vector_pvacuum_double_t_pop", _wrap_vector_pvacuum_double_t_pop, METH_O, "vector_pvacuum_double_t_pop(vector_pvacuum_double_t self) -> pvacuum_double_t"},
-	 { "vector_pvacuum_double_t_append", _wrap_vector_pvacuum_double_t_append, METH_VARARGS, "vector_pvacuum_double_t_append(vector_pvacuum_double_t self, pvacuum_double_t x)"},
-	 { "vector_pvacuum_double_t_empty", _wrap_vector_pvacuum_double_t_empty, METH_O, "vector_pvacuum_double_t_empty(vector_pvacuum_double_t self) -> bool"},
-	 { "vector_pvacuum_double_t_size", _wrap_vector_pvacuum_double_t_size, METH_O, "vector_pvacuum_double_t_size(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::size_type"},
-	 { "vector_pvacuum_double_t_swap", _wrap_vector_pvacuum_double_t_swap, METH_VARARGS, "vector_pvacuum_double_t_swap(vector_pvacuum_double_t self, vector_pvacuum_double_t v)"},
-	 { "vector_pvacuum_double_t_begin", _wrap_vector_pvacuum_double_t_begin, METH_O, "vector_pvacuum_double_t_begin(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::iterator"},
-	 { "vector_pvacuum_double_t_end", _wrap_vector_pvacuum_double_t_end, METH_O, "vector_pvacuum_double_t_end(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::iterator"},
-	 { "vector_pvacuum_double_t_rbegin", _wrap_vector_pvacuum_double_t_rbegin, METH_O, "vector_pvacuum_double_t_rbegin(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::reverse_iterator"},
-	 { "vector_pvacuum_double_t_rend", _wrap_vector_pvacuum_double_t_rend, METH_O, "vector_pvacuum_double_t_rend(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::reverse_iterator"},
-	 { "vector_pvacuum_double_t_clear", _wrap_vector_pvacuum_double_t_clear, METH_O, "vector_pvacuum_double_t_clear(vector_pvacuum_double_t self)"},
-	 { "vector_pvacuum_double_t_get_allocator", _wrap_vector_pvacuum_double_t_get_allocator, METH_O, "vector_pvacuum_double_t_get_allocator(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::allocator_type"},
-	 { "vector_pvacuum_double_t_pop_back", _wrap_vector_pvacuum_double_t_pop_back, METH_O, "vector_pvacuum_double_t_pop_back(vector_pvacuum_double_t self)"},
-	 { "vector_pvacuum_double_t_erase", _wrap_vector_pvacuum_double_t_erase, METH_VARARGS, "\n"
-		"vector_pvacuum_double_t_erase(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::iterator pos) -> std::vector< std::pair< double,double > >::iterator\n"
-		"vector_pvacuum_double_t_erase(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::iterator first, std::vector< std::pair< double,double > >::iterator last) -> std::vector< std::pair< double,double > >::iterator\n"
+	 { "vector_pvacuum_double_T_pop", _wrap_vector_pvacuum_double_T_pop, METH_O, "vector_pvacuum_double_T_pop(vector_pvacuum_double_T self) -> pvacuum_double_T"},
+	 { "vector_pvacuum_double_T_append", _wrap_vector_pvacuum_double_T_append, METH_VARARGS, "vector_pvacuum_double_T_append(vector_pvacuum_double_T self, pvacuum_double_T x)"},
+	 { "vector_pvacuum_double_T_empty", _wrap_vector_pvacuum_double_T_empty, METH_O, "vector_pvacuum_double_T_empty(vector_pvacuum_double_T self) -> bool"},
+	 { "vector_pvacuum_double_T_size", _wrap_vector_pvacuum_double_T_size, METH_O, "vector_pvacuum_double_T_size(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::size_type"},
+	 { "vector_pvacuum_double_T_swap", _wrap_vector_pvacuum_double_T_swap, METH_VARARGS, "vector_pvacuum_double_T_swap(vector_pvacuum_double_T self, vector_pvacuum_double_T v)"},
+	 { "vector_pvacuum_double_T_begin", _wrap_vector_pvacuum_double_T_begin, METH_O, "vector_pvacuum_double_T_begin(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::iterator"},
+	 { "vector_pvacuum_double_T_end", _wrap_vector_pvacuum_double_T_end, METH_O, "vector_pvacuum_double_T_end(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::iterator"},
+	 { "vector_pvacuum_double_T_rbegin", _wrap_vector_pvacuum_double_T_rbegin, METH_O, "vector_pvacuum_double_T_rbegin(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::reverse_iterator"},
+	 { "vector_pvacuum_double_T_rend", _wrap_vector_pvacuum_double_T_rend, METH_O, "vector_pvacuum_double_T_rend(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::reverse_iterator"},
+	 { "vector_pvacuum_double_T_clear", _wrap_vector_pvacuum_double_T_clear, METH_O, "vector_pvacuum_double_T_clear(vector_pvacuum_double_T self)"},
+	 { "vector_pvacuum_double_T_get_allocator", _wrap_vector_pvacuum_double_T_get_allocator, METH_O, "vector_pvacuum_double_T_get_allocator(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::allocator_type"},
+	 { "vector_pvacuum_double_T_pop_back", _wrap_vector_pvacuum_double_T_pop_back, METH_O, "vector_pvacuum_double_T_pop_back(vector_pvacuum_double_T self)"},
+	 { "vector_pvacuum_double_T_erase", _wrap_vector_pvacuum_double_T_erase, METH_VARARGS, "\n"
+		"vector_pvacuum_double_T_erase(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::iterator pos) -> std::vector< std::pair< double,double > >::iterator\n"
+		"vector_pvacuum_double_T_erase(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::iterator first, std::vector< std::pair< double,double > >::iterator last) -> std::vector< std::pair< double,double > >::iterator\n"
 		""},
-	 { "new_vector_pvacuum_double_t", _wrap_new_vector_pvacuum_double_t, METH_VARARGS, "\n"
-		"vector_pvacuum_double_t()\n"
-		"vector_pvacuum_double_t(vector_pvacuum_double_t other)\n"
-		"vector_pvacuum_double_t(std::vector< std::pair< double,double > >::size_type size)\n"
-		"new_vector_pvacuum_double_t(std::vector< std::pair< double,double > >::size_type size, pvacuum_double_t value) -> vector_pvacuum_double_t\n"
+	 { "new_vector_pvacuum_double_T", _wrap_new_vector_pvacuum_double_T, METH_VARARGS, "\n"
+		"vector_pvacuum_double_T()\n"
+		"vector_pvacuum_double_T(vector_pvacuum_double_T other)\n"
+		"vector_pvacuum_double_T(std::vector< std::pair< double,double > >::size_type size)\n"
+		"new_vector_pvacuum_double_T(std::vector< std::pair< double,double > >::size_type size, pvacuum_double_T value) -> vector_pvacuum_double_T\n"
 		""},
-	 { "vector_pvacuum_double_t_push_back", _wrap_vector_pvacuum_double_t_push_back, METH_VARARGS, "vector_pvacuum_double_t_push_back(vector_pvacuum_double_t self, pvacuum_double_t x)"},
-	 { "vector_pvacuum_double_t_front", _wrap_vector_pvacuum_double_t_front, METH_O, "vector_pvacuum_double_t_front(vector_pvacuum_double_t self) -> pvacuum_double_t"},
-	 { "vector_pvacuum_double_t_back", _wrap_vector_pvacuum_double_t_back, METH_O, "vector_pvacuum_double_t_back(vector_pvacuum_double_t self) -> pvacuum_double_t"},
-	 { "vector_pvacuum_double_t_assign", _wrap_vector_pvacuum_double_t_assign, METH_VARARGS, "vector_pvacuum_double_t_assign(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::size_type n, pvacuum_double_t x)"},
-	 { "vector_pvacuum_double_t_resize", _wrap_vector_pvacuum_double_t_resize, METH_VARARGS, "\n"
-		"vector_pvacuum_double_t_resize(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::size_type new_size)\n"
-		"vector_pvacuum_double_t_resize(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::size_type new_size, pvacuum_double_t x)\n"
+	 { "vector_pvacuum_double_T_push_back", _wrap_vector_pvacuum_double_T_push_back, METH_VARARGS, "vector_pvacuum_double_T_push_back(vector_pvacuum_double_T self, pvacuum_double_T x)"},
+	 { "vector_pvacuum_double_T_front", _wrap_vector_pvacuum_double_T_front, METH_O, "vector_pvacuum_double_T_front(vector_pvacuum_double_T self) -> pvacuum_double_T"},
+	 { "vector_pvacuum_double_T_back", _wrap_vector_pvacuum_double_T_back, METH_O, "vector_pvacuum_double_T_back(vector_pvacuum_double_T self) -> pvacuum_double_T"},
+	 { "vector_pvacuum_double_T_assign", _wrap_vector_pvacuum_double_T_assign, METH_VARARGS, "vector_pvacuum_double_T_assign(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::size_type n, pvacuum_double_T x)"},
+	 { "vector_pvacuum_double_T_resize", _wrap_vector_pvacuum_double_T_resize, METH_VARARGS, "\n"
+		"vector_pvacuum_double_T_resize(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::size_type new_size)\n"
+		"vector_pvacuum_double_T_resize(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::size_type new_size, pvacuum_double_T x)\n"
 		""},
-	 { "vector_pvacuum_double_t_insert", _wrap_vector_pvacuum_double_t_insert, METH_VARARGS, "\n"
-		"vector_pvacuum_double_t_insert(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::iterator pos, pvacuum_double_t x) -> std::vector< std::pair< double,double > >::iterator\n"
-		"vector_pvacuum_double_t_insert(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::iterator pos, std::vector< std::pair< double,double > >::size_type n, pvacuum_double_t x)\n"
+	 { "vector_pvacuum_double_T_insert", _wrap_vector_pvacuum_double_T_insert, METH_VARARGS, "\n"
+		"vector_pvacuum_double_T_insert(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::iterator pos, pvacuum_double_T x) -> std::vector< std::pair< double,double > >::iterator\n"
+		"vector_pvacuum_double_T_insert(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::iterator pos, std::vector< std::pair< double,double > >::size_type n, pvacuum_double_T x)\n"
 		""},
-	 { "vector_pvacuum_double_t_reserve", _wrap_vector_pvacuum_double_t_reserve, METH_VARARGS, "vector_pvacuum_double_t_reserve(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::size_type n)"},
-	 { "vector_pvacuum_double_t_capacity", _wrap_vector_pvacuum_double_t_capacity, METH_O, "vector_pvacuum_double_t_capacity(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::size_type"},
-	 { "delete_vector_pvacuum_double_t", _wrap_delete_vector_pvacuum_double_t, METH_O, "delete_vector_pvacuum_double_t(vector_pvacuum_double_t self)"},
-	 { "vector_pvacuum_double_t_swigregister", vector_pvacuum_double_t_swigregister, METH_O, NULL},
-	 { "vector_pvacuum_double_t_swiginit", vector_pvacuum_double_t_swiginit, METH_VARARGS, NULL},
+	 { "vector_pvacuum_double_T_reserve", _wrap_vector_pvacuum_double_T_reserve, METH_VARARGS, "vector_pvacuum_double_T_reserve(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::size_type n)"},
+	 { "vector_pvacuum_double_T_capacity", _wrap_vector_pvacuum_double_T_capacity, METH_O, "vector_pvacuum_double_T_capacity(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::size_type"},
+	 { "delete_vector_pvacuum_double_T", _wrap_delete_vector_pvacuum_double_T, METH_O, "delete_vector_pvacuum_double_T(vector_pvacuum_double_T self)"},
+	 { "vector_pvacuum_double_T_swigregister", vector_pvacuum_double_T_swigregister, METH_O, NULL},
+	 { "vector_pvacuum_double_T_swiginit", vector_pvacuum_double_T_swiginit, METH_VARARGS, NULL},
 	 { "swig_dummy_type_const_inode_vector_iterator", _wrap_swig_dummy_type_const_inode_vector_iterator, METH_O, "swig_dummy_type_const_inode_vector_iterator(swig_dummy_type_const_inode_vector self) -> SwigPyIterator"},
 	 { "swig_dummy_type_const_inode_vector___nonzero__", _wrap_swig_dummy_type_const_inode_vector___nonzero__, METH_O, "swig_dummy_type_const_inode_vector___nonzero__(swig_dummy_type_const_inode_vector self) -> bool"},
 	 { "swig_dummy_type_const_inode_vector___bool__", _wrap_swig_dummy_type_const_inode_vector___bool__, METH_O, "swig_dummy_type_const_inode_vector___bool__(swig_dummy_type_const_inode_vector self) -> bool"},
@@ -33519,14 +33519,14 @@ static PyMethodDef SwigMethods[] = {
 	 { "ParaMeta_swiginit", ParaMeta_swiginit, METH_VARARGS, NULL},
 	 { "new_INode", _wrap_new_INode, METH_VARARGS, "\n"
 		"INode()\n"
-		"new_INode(PyObject * _self, vdouble1d_t PValues) -> INode\n"
+		"new_INode(PyObject * _self, vdouble1d_T PValues) -> INode\n"
 		""},
 	 { "delete_INode", _wrap_delete_INode, METH_O, "delete_INode(INode self)"},
 	 { "INode_className", _wrap_INode_className, METH_O, "INode_className(INode self) -> std::string"},
 	 { "INode_nodeChildren", _wrap_INode_nodeChildren, METH_O, "INode_nodeChildren(INode self) -> swig_dummy_type_const_inode_vector"},
 	 { "INode_nodeOffspring", _wrap_INode_nodeOffspring, METH_O, "INode_nodeOffspring(INode self) -> swig_dummy_type_const_inode_vector"},
 	 { "INode_parDefs", _wrap_INode_parDefs, METH_O, "INode_parDefs(INode self) -> std::vector< ParaMeta,std::allocator< ParaMeta > >"},
-	 { "INode_pars", _wrap_INode_pars, METH_O, "INode_pars(INode self) -> vdouble1d_t"},
+	 { "INode_pars", _wrap_INode_pars, METH_O, "INode_pars(INode self) -> vdouble1d_T"},
 	 { "INode_nPars", _wrap_INode_nPars, METH_O, "INode_nPars(INode self) -> size_t"},
 	 { "INode_parVal", _wrap_INode_parVal, METH_VARARGS, "INode_parVal(INode self, size_t i) -> double"},
 	 { "INode_validate", _wrap_INode_validate, METH_O, "INode_validate(INode self) -> std::string"},
@@ -33549,7 +33549,7 @@ static PyMethodDef SwigMethods[] = {
 	 { "delete_IDistribution1D", _wrap_delete_IDistribution1D, METH_O, "delete_IDistribution1D(IDistribution1D self)"},
 	 { "IDistribution1D_swigregister", IDistribution1D_swigregister, METH_O, NULL},
 	 { "new_DistributionGate", _wrap_new_DistributionGate, METH_VARARGS, "\n"
-		"DistributionGate(vdouble1d_t P, size_t n_samples)\n"
+		"DistributionGate(vdouble1d_T P, size_t n_samples)\n"
 		"DistributionGate(double min, double max, size_t n_samples=25)\n"
 		""},
 	 { "DistributionGate_className", _wrap_DistributionGate_className, METH_O, "DistributionGate_className(DistributionGate self) -> std::string"},
@@ -33559,7 +33559,7 @@ static PyMethodDef SwigMethods[] = {
 	 { "DistributionGate_swigregister", DistributionGate_swigregister, METH_O, NULL},
 	 { "DistributionGate_swiginit", DistributionGate_swiginit, METH_VARARGS, NULL},
 	 { "new_DistributionLorentz", _wrap_new_DistributionLorentz, METH_VARARGS, "\n"
-		"DistributionLorentz(vdouble1d_t P, size_t n_samples, double rel_sampling_width)\n"
+		"DistributionLorentz(vdouble1d_T P, size_t n_samples, double rel_sampling_width)\n"
 		"DistributionLorentz(double mean, double hwhm, size_t n_samples=25, double rel_sampling_width=2.)\n"
 		""},
 	 { "DistributionLorentz_className", _wrap_DistributionLorentz_className, METH_O, "DistributionLorentz_className(DistributionLorentz self) -> std::string"},
@@ -33569,7 +33569,7 @@ static PyMethodDef SwigMethods[] = {
 	 { "DistributionLorentz_swigregister", DistributionLorentz_swigregister, METH_O, NULL},
 	 { "DistributionLorentz_swiginit", DistributionLorentz_swiginit, METH_VARARGS, NULL},
 	 { "new_DistributionGaussian", _wrap_new_DistributionGaussian, METH_VARARGS, "\n"
-		"DistributionGaussian(vdouble1d_t P, size_t n_samples, double rel_sampling_width)\n"
+		"DistributionGaussian(vdouble1d_T P, size_t n_samples, double rel_sampling_width)\n"
 		"DistributionGaussian(double mean, double std_dev, size_t n_samples=25, double rel_sampling_width=2.)\n"
 		""},
 	 { "DistributionGaussian_clone", _wrap_DistributionGaussian_clone, METH_O, "DistributionGaussian_clone(DistributionGaussian self) -> DistributionGaussian"},
@@ -33579,7 +33579,7 @@ static PyMethodDef SwigMethods[] = {
 	 { "DistributionGaussian_swigregister", DistributionGaussian_swigregister, METH_O, NULL},
 	 { "DistributionGaussian_swiginit", DistributionGaussian_swiginit, METH_VARARGS, NULL},
 	 { "new_DistributionLogNormal", _wrap_new_DistributionLogNormal, METH_VARARGS, "\n"
-		"DistributionLogNormal(vdouble1d_t P, size_t n_samples, double rel_sampling_width)\n"
+		"DistributionLogNormal(vdouble1d_T P, size_t n_samples, double rel_sampling_width)\n"
 		"DistributionLogNormal(double median, double scale_param, size_t n_samples=25, double rel_sampling_width=2.)\n"
 		""},
 	 { "DistributionLogNormal_className", _wrap_DistributionLogNormal_className, METH_O, "DistributionLogNormal_className(DistributionLogNormal self) -> std::string"},
@@ -33589,7 +33589,7 @@ static PyMethodDef SwigMethods[] = {
 	 { "DistributionLogNormal_swigregister", DistributionLogNormal_swigregister, METH_O, NULL},
 	 { "DistributionLogNormal_swiginit", DistributionLogNormal_swiginit, METH_VARARGS, NULL},
 	 { "new_DistributionCosine", _wrap_new_DistributionCosine, METH_VARARGS, "\n"
-		"DistributionCosine(vdouble1d_t P, size_t n_samples)\n"
+		"DistributionCosine(vdouble1d_T P, size_t n_samples)\n"
 		"DistributionCosine(double mean, double sigma, size_t n_samples=25)\n"
 		""},
 	 { "DistributionCosine_className", _wrap_DistributionCosine_className, METH_O, "DistributionCosine_className(DistributionCosine self) -> std::string"},
diff --git a/auto/Wrap/libBornAgainResample.py b/auto/Wrap/libBornAgainResample.py
index e97cdf8ccc276f8a48d0c10d6aa49bff418b0206..372210715be13d2cad0a7cd1278089994efc9493 100644
--- a/auto/Wrap/libBornAgainResample.py
+++ b/auto/Wrap/libBornAgainResample.py
@@ -153,1191 +153,1191 @@ def deprecated(message):
       return deprecated_func
   return deprecated_decorator
 
-class vdouble1d_t(object):
+class vdouble1d_T(object):
     r"""Proxy of C++ std::vector< double > class."""
 
     thisown = property(lambda x: x.this.own(), lambda x, v: x.this.own(v), doc="The membership flag")
     __repr__ = _swig_repr
 
     def iterator(self):
-        r"""iterator(vdouble1d_t self) -> SwigPyIterator"""
-        return _libBornAgainResample.vdouble1d_t_iterator(self)
+        r"""iterator(vdouble1d_T self) -> SwigPyIterator"""
+        return _libBornAgainResample.vdouble1d_T_iterator(self)
     def __iter__(self):
         return self.iterator()
 
     def __nonzero__(self):
-        r"""__nonzero__(vdouble1d_t self) -> bool"""
-        return _libBornAgainResample.vdouble1d_t___nonzero__(self)
+        r"""__nonzero__(vdouble1d_T self) -> bool"""
+        return _libBornAgainResample.vdouble1d_T___nonzero__(self)
 
     def __bool__(self):
-        r"""__bool__(vdouble1d_t self) -> bool"""
-        return _libBornAgainResample.vdouble1d_t___bool__(self)
+        r"""__bool__(vdouble1d_T self) -> bool"""
+        return _libBornAgainResample.vdouble1d_T___bool__(self)
 
     def __len__(self):
-        r"""__len__(vdouble1d_t self) -> std::vector< double >::size_type"""
-        return _libBornAgainResample.vdouble1d_t___len__(self)
+        r"""__len__(vdouble1d_T self) -> std::vector< double >::size_type"""
+        return _libBornAgainResample.vdouble1d_T___len__(self)
 
     def __getslice__(self, i, j):
-        r"""__getslice__(vdouble1d_t self, std::vector< double >::difference_type i, std::vector< double >::difference_type j) -> vdouble1d_t"""
-        return _libBornAgainResample.vdouble1d_t___getslice__(self, i, j)
+        r"""__getslice__(vdouble1d_T self, std::vector< double >::difference_type i, std::vector< double >::difference_type j) -> vdouble1d_T"""
+        return _libBornAgainResample.vdouble1d_T___getslice__(self, i, j)
 
     def __setslice__(self, *args):
         r"""
-        __setslice__(vdouble1d_t self, std::vector< double >::difference_type i, std::vector< double >::difference_type j)
-        __setslice__(vdouble1d_t self, std::vector< double >::difference_type i, std::vector< double >::difference_type j, vdouble1d_t v)
+        __setslice__(vdouble1d_T self, std::vector< double >::difference_type i, std::vector< double >::difference_type j)
+        __setslice__(vdouble1d_T self, std::vector< double >::difference_type i, std::vector< double >::difference_type j, vdouble1d_T v)
         """
-        return _libBornAgainResample.vdouble1d_t___setslice__(self, *args)
+        return _libBornAgainResample.vdouble1d_T___setslice__(self, *args)
 
     def __delslice__(self, i, j):
-        r"""__delslice__(vdouble1d_t self, std::vector< double >::difference_type i, std::vector< double >::difference_type j)"""
-        return _libBornAgainResample.vdouble1d_t___delslice__(self, i, j)
+        r"""__delslice__(vdouble1d_T self, std::vector< double >::difference_type i, std::vector< double >::difference_type j)"""
+        return _libBornAgainResample.vdouble1d_T___delslice__(self, i, j)
 
     def __delitem__(self, *args):
         r"""
-        __delitem__(vdouble1d_t self, std::vector< double >::difference_type i)
-        __delitem__(vdouble1d_t self, SWIGPY_SLICEOBJECT * slice)
+        __delitem__(vdouble1d_T self, std::vector< double >::difference_type i)
+        __delitem__(vdouble1d_T self, SWIGPY_SLICEOBJECT * slice)
         """
-        return _libBornAgainResample.vdouble1d_t___delitem__(self, *args)
+        return _libBornAgainResample.vdouble1d_T___delitem__(self, *args)
 
     def __getitem__(self, *args):
         r"""
-        __getitem__(vdouble1d_t self, SWIGPY_SLICEOBJECT * slice) -> vdouble1d_t
-        __getitem__(vdouble1d_t self, std::vector< double >::difference_type i) -> std::vector< double >::value_type const &
+        __getitem__(vdouble1d_T self, SWIGPY_SLICEOBJECT * slice) -> vdouble1d_T
+        __getitem__(vdouble1d_T self, std::vector< double >::difference_type i) -> std::vector< double >::value_type const &
         """
-        return _libBornAgainResample.vdouble1d_t___getitem__(self, *args)
+        return _libBornAgainResample.vdouble1d_T___getitem__(self, *args)
 
     def __setitem__(self, *args):
         r"""
-        __setitem__(vdouble1d_t self, SWIGPY_SLICEOBJECT * slice, vdouble1d_t v)
-        __setitem__(vdouble1d_t self, SWIGPY_SLICEOBJECT * slice)
-        __setitem__(vdouble1d_t self, std::vector< double >::difference_type i, std::vector< double >::value_type const & x)
+        __setitem__(vdouble1d_T self, SWIGPY_SLICEOBJECT * slice, vdouble1d_T v)
+        __setitem__(vdouble1d_T self, SWIGPY_SLICEOBJECT * slice)
+        __setitem__(vdouble1d_T self, std::vector< double >::difference_type i, std::vector< double >::value_type const & x)
         """
-        return _libBornAgainResample.vdouble1d_t___setitem__(self, *args)
+        return _libBornAgainResample.vdouble1d_T___setitem__(self, *args)
 
     def pop(self):
-        r"""pop(vdouble1d_t self) -> std::vector< double >::value_type"""
-        return _libBornAgainResample.vdouble1d_t_pop(self)
+        r"""pop(vdouble1d_T self) -> std::vector< double >::value_type"""
+        return _libBornAgainResample.vdouble1d_T_pop(self)
 
     def append(self, x):
-        r"""append(vdouble1d_t self, std::vector< double >::value_type const & x)"""
-        return _libBornAgainResample.vdouble1d_t_append(self, x)
+        r"""append(vdouble1d_T self, std::vector< double >::value_type const & x)"""
+        return _libBornAgainResample.vdouble1d_T_append(self, x)
 
     def empty(self):
-        r"""empty(vdouble1d_t self) -> bool"""
-        return _libBornAgainResample.vdouble1d_t_empty(self)
+        r"""empty(vdouble1d_T self) -> bool"""
+        return _libBornAgainResample.vdouble1d_T_empty(self)
 
     def size(self):
-        r"""size(vdouble1d_t self) -> std::vector< double >::size_type"""
-        return _libBornAgainResample.vdouble1d_t_size(self)
+        r"""size(vdouble1d_T self) -> std::vector< double >::size_type"""
+        return _libBornAgainResample.vdouble1d_T_size(self)
 
     def swap(self, v):
-        r"""swap(vdouble1d_t self, vdouble1d_t v)"""
-        return _libBornAgainResample.vdouble1d_t_swap(self, v)
+        r"""swap(vdouble1d_T self, vdouble1d_T v)"""
+        return _libBornAgainResample.vdouble1d_T_swap(self, v)
 
     def begin(self):
-        r"""begin(vdouble1d_t self) -> std::vector< double >::iterator"""
-        return _libBornAgainResample.vdouble1d_t_begin(self)
+        r"""begin(vdouble1d_T self) -> std::vector< double >::iterator"""
+        return _libBornAgainResample.vdouble1d_T_begin(self)
 
     def end(self):
-        r"""end(vdouble1d_t self) -> std::vector< double >::iterator"""
-        return _libBornAgainResample.vdouble1d_t_end(self)
+        r"""end(vdouble1d_T self) -> std::vector< double >::iterator"""
+        return _libBornAgainResample.vdouble1d_T_end(self)
 
     def rbegin(self):
-        r"""rbegin(vdouble1d_t self) -> std::vector< double >::reverse_iterator"""
-        return _libBornAgainResample.vdouble1d_t_rbegin(self)
+        r"""rbegin(vdouble1d_T self) -> std::vector< double >::reverse_iterator"""
+        return _libBornAgainResample.vdouble1d_T_rbegin(self)
 
     def rend(self):
-        r"""rend(vdouble1d_t self) -> std::vector< double >::reverse_iterator"""
-        return _libBornAgainResample.vdouble1d_t_rend(self)
+        r"""rend(vdouble1d_T self) -> std::vector< double >::reverse_iterator"""
+        return _libBornAgainResample.vdouble1d_T_rend(self)
 
     def clear(self):
-        r"""clear(vdouble1d_t self)"""
-        return _libBornAgainResample.vdouble1d_t_clear(self)
+        r"""clear(vdouble1d_T self)"""
+        return _libBornAgainResample.vdouble1d_T_clear(self)
 
     def get_allocator(self):
-        r"""get_allocator(vdouble1d_t self) -> std::vector< double >::allocator_type"""
-        return _libBornAgainResample.vdouble1d_t_get_allocator(self)
+        r"""get_allocator(vdouble1d_T self) -> std::vector< double >::allocator_type"""
+        return _libBornAgainResample.vdouble1d_T_get_allocator(self)
 
     def pop_back(self):
-        r"""pop_back(vdouble1d_t self)"""
-        return _libBornAgainResample.vdouble1d_t_pop_back(self)
+        r"""pop_back(vdouble1d_T self)"""
+        return _libBornAgainResample.vdouble1d_T_pop_back(self)
 
     def erase(self, *args):
         r"""
-        erase(vdouble1d_t self, std::vector< double >::iterator pos) -> std::vector< double >::iterator
-        erase(vdouble1d_t self, std::vector< double >::iterator first, std::vector< double >::iterator last) -> std::vector< double >::iterator
+        erase(vdouble1d_T self, std::vector< double >::iterator pos) -> std::vector< double >::iterator
+        erase(vdouble1d_T self, std::vector< double >::iterator first, std::vector< double >::iterator last) -> std::vector< double >::iterator
         """
-        return _libBornAgainResample.vdouble1d_t_erase(self, *args)
+        return _libBornAgainResample.vdouble1d_T_erase(self, *args)
 
     def __init__(self, *args):
         r"""
-        __init__(vdouble1d_t self) -> vdouble1d_t
-        __init__(vdouble1d_t self, vdouble1d_t other) -> vdouble1d_t
-        __init__(vdouble1d_t self, std::vector< double >::size_type size) -> vdouble1d_t
-        __init__(vdouble1d_t self, std::vector< double >::size_type size, std::vector< double >::value_type const & value) -> vdouble1d_t
+        __init__(vdouble1d_T self) -> vdouble1d_T
+        __init__(vdouble1d_T self, vdouble1d_T other) -> vdouble1d_T
+        __init__(vdouble1d_T self, std::vector< double >::size_type size) -> vdouble1d_T
+        __init__(vdouble1d_T self, std::vector< double >::size_type size, std::vector< double >::value_type const & value) -> vdouble1d_T
         """
-        _libBornAgainResample.vdouble1d_t_swiginit(self, _libBornAgainResample.new_vdouble1d_t(*args))
+        _libBornAgainResample.vdouble1d_T_swiginit(self, _libBornAgainResample.new_vdouble1d_T(*args))
 
     def push_back(self, x):
-        r"""push_back(vdouble1d_t self, std::vector< double >::value_type const & x)"""
-        return _libBornAgainResample.vdouble1d_t_push_back(self, x)
+        r"""push_back(vdouble1d_T self, std::vector< double >::value_type const & x)"""
+        return _libBornAgainResample.vdouble1d_T_push_back(self, x)
 
     def front(self):
-        r"""front(vdouble1d_t self) -> std::vector< double >::value_type const &"""
-        return _libBornAgainResample.vdouble1d_t_front(self)
+        r"""front(vdouble1d_T self) -> std::vector< double >::value_type const &"""
+        return _libBornAgainResample.vdouble1d_T_front(self)
 
     def back(self):
-        r"""back(vdouble1d_t self) -> std::vector< double >::value_type const &"""
-        return _libBornAgainResample.vdouble1d_t_back(self)
+        r"""back(vdouble1d_T self) -> std::vector< double >::value_type const &"""
+        return _libBornAgainResample.vdouble1d_T_back(self)
 
     def assign(self, n, x):
-        r"""assign(vdouble1d_t self, std::vector< double >::size_type n, std::vector< double >::value_type const & x)"""
-        return _libBornAgainResample.vdouble1d_t_assign(self, n, x)
+        r"""assign(vdouble1d_T self, std::vector< double >::size_type n, std::vector< double >::value_type const & x)"""
+        return _libBornAgainResample.vdouble1d_T_assign(self, n, x)
 
     def resize(self, *args):
         r"""
-        resize(vdouble1d_t self, std::vector< double >::size_type new_size)
-        resize(vdouble1d_t self, std::vector< double >::size_type new_size, std::vector< double >::value_type const & x)
+        resize(vdouble1d_T self, std::vector< double >::size_type new_size)
+        resize(vdouble1d_T self, std::vector< double >::size_type new_size, std::vector< double >::value_type const & x)
         """
-        return _libBornAgainResample.vdouble1d_t_resize(self, *args)
+        return _libBornAgainResample.vdouble1d_T_resize(self, *args)
 
     def insert(self, *args):
         r"""
-        insert(vdouble1d_t self, std::vector< double >::iterator pos, std::vector< double >::value_type const & x) -> std::vector< double >::iterator
-        insert(vdouble1d_t self, std::vector< double >::iterator pos, std::vector< double >::size_type n, std::vector< double >::value_type const & x)
+        insert(vdouble1d_T self, std::vector< double >::iterator pos, std::vector< double >::value_type const & x) -> std::vector< double >::iterator
+        insert(vdouble1d_T self, std::vector< double >::iterator pos, std::vector< double >::size_type n, std::vector< double >::value_type const & x)
         """
-        return _libBornAgainResample.vdouble1d_t_insert(self, *args)
+        return _libBornAgainResample.vdouble1d_T_insert(self, *args)
 
     def reserve(self, n):
-        r"""reserve(vdouble1d_t self, std::vector< double >::size_type n)"""
-        return _libBornAgainResample.vdouble1d_t_reserve(self, n)
+        r"""reserve(vdouble1d_T self, std::vector< double >::size_type n)"""
+        return _libBornAgainResample.vdouble1d_T_reserve(self, n)
 
     def capacity(self):
-        r"""capacity(vdouble1d_t self) -> std::vector< double >::size_type"""
-        return _libBornAgainResample.vdouble1d_t_capacity(self)
-    __swig_destroy__ = _libBornAgainResample.delete_vdouble1d_t
+        r"""capacity(vdouble1d_T self) -> std::vector< double >::size_type"""
+        return _libBornAgainResample.vdouble1d_T_capacity(self)
+    __swig_destroy__ = _libBornAgainResample.delete_vdouble1d_T
 
-# Register vdouble1d_t in _libBornAgainResample:
-_libBornAgainResample.vdouble1d_t_swigregister(vdouble1d_t)
-class vdouble2d_t(object):
+# Register vdouble1d_T in _libBornAgainResample:
+_libBornAgainResample.vdouble1d_T_swigregister(vdouble1d_T)
+class vdouble2d_T(object):
     r"""Proxy of C++ std::vector< std::vector< double > > class."""
 
     thisown = property(lambda x: x.this.own(), lambda x, v: x.this.own(v), doc="The membership flag")
     __repr__ = _swig_repr
 
     def iterator(self):
-        r"""iterator(vdouble2d_t self) -> SwigPyIterator"""
-        return _libBornAgainResample.vdouble2d_t_iterator(self)
+        r"""iterator(vdouble2d_T self) -> SwigPyIterator"""
+        return _libBornAgainResample.vdouble2d_T_iterator(self)
     def __iter__(self):
         return self.iterator()
 
     def __nonzero__(self):
-        r"""__nonzero__(vdouble2d_t self) -> bool"""
-        return _libBornAgainResample.vdouble2d_t___nonzero__(self)
+        r"""__nonzero__(vdouble2d_T self) -> bool"""
+        return _libBornAgainResample.vdouble2d_T___nonzero__(self)
 
     def __bool__(self):
-        r"""__bool__(vdouble2d_t self) -> bool"""
-        return _libBornAgainResample.vdouble2d_t___bool__(self)
+        r"""__bool__(vdouble2d_T self) -> bool"""
+        return _libBornAgainResample.vdouble2d_T___bool__(self)
 
     def __len__(self):
-        r"""__len__(vdouble2d_t self) -> std::vector< std::vector< double > >::size_type"""
-        return _libBornAgainResample.vdouble2d_t___len__(self)
+        r"""__len__(vdouble2d_T self) -> std::vector< std::vector< double > >::size_type"""
+        return _libBornAgainResample.vdouble2d_T___len__(self)
 
     def __getslice__(self, i, j):
-        r"""__getslice__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j) -> vdouble2d_t"""
-        return _libBornAgainResample.vdouble2d_t___getslice__(self, i, j)
+        r"""__getslice__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j) -> vdouble2d_T"""
+        return _libBornAgainResample.vdouble2d_T___getslice__(self, i, j)
 
     def __setslice__(self, *args):
         r"""
-        __setslice__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j)
-        __setslice__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j, vdouble2d_t v)
+        __setslice__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j)
+        __setslice__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j, vdouble2d_T v)
         """
-        return _libBornAgainResample.vdouble2d_t___setslice__(self, *args)
+        return _libBornAgainResample.vdouble2d_T___setslice__(self, *args)
 
     def __delslice__(self, i, j):
-        r"""__delslice__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j)"""
-        return _libBornAgainResample.vdouble2d_t___delslice__(self, i, j)
+        r"""__delslice__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j)"""
+        return _libBornAgainResample.vdouble2d_T___delslice__(self, i, j)
 
     def __delitem__(self, *args):
         r"""
-        __delitem__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i)
-        __delitem__(vdouble2d_t self, SWIGPY_SLICEOBJECT * slice)
+        __delitem__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i)
+        __delitem__(vdouble2d_T self, SWIGPY_SLICEOBJECT * slice)
         """
-        return _libBornAgainResample.vdouble2d_t___delitem__(self, *args)
+        return _libBornAgainResample.vdouble2d_T___delitem__(self, *args)
 
     def __getitem__(self, *args):
         r"""
-        __getitem__(vdouble2d_t self, SWIGPY_SLICEOBJECT * slice) -> vdouble2d_t
-        __getitem__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i) -> vdouble1d_t
+        __getitem__(vdouble2d_T self, SWIGPY_SLICEOBJECT * slice) -> vdouble2d_T
+        __getitem__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i) -> vdouble1d_T
         """
-        return _libBornAgainResample.vdouble2d_t___getitem__(self, *args)
+        return _libBornAgainResample.vdouble2d_T___getitem__(self, *args)
 
     def __setitem__(self, *args):
         r"""
-        __setitem__(vdouble2d_t self, SWIGPY_SLICEOBJECT * slice, vdouble2d_t v)
-        __setitem__(vdouble2d_t self, SWIGPY_SLICEOBJECT * slice)
-        __setitem__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i, vdouble1d_t x)
+        __setitem__(vdouble2d_T self, SWIGPY_SLICEOBJECT * slice, vdouble2d_T v)
+        __setitem__(vdouble2d_T self, SWIGPY_SLICEOBJECT * slice)
+        __setitem__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i, vdouble1d_T x)
         """
-        return _libBornAgainResample.vdouble2d_t___setitem__(self, *args)
+        return _libBornAgainResample.vdouble2d_T___setitem__(self, *args)
 
     def pop(self):
-        r"""pop(vdouble2d_t self) -> vdouble1d_t"""
-        return _libBornAgainResample.vdouble2d_t_pop(self)
+        r"""pop(vdouble2d_T self) -> vdouble1d_T"""
+        return _libBornAgainResample.vdouble2d_T_pop(self)
 
     def append(self, x):
-        r"""append(vdouble2d_t self, vdouble1d_t x)"""
-        return _libBornAgainResample.vdouble2d_t_append(self, x)
+        r"""append(vdouble2d_T self, vdouble1d_T x)"""
+        return _libBornAgainResample.vdouble2d_T_append(self, x)
 
     def empty(self):
-        r"""empty(vdouble2d_t self) -> bool"""
-        return _libBornAgainResample.vdouble2d_t_empty(self)
+        r"""empty(vdouble2d_T self) -> bool"""
+        return _libBornAgainResample.vdouble2d_T_empty(self)
 
     def size(self):
-        r"""size(vdouble2d_t self) -> std::vector< std::vector< double > >::size_type"""
-        return _libBornAgainResample.vdouble2d_t_size(self)
+        r"""size(vdouble2d_T self) -> std::vector< std::vector< double > >::size_type"""
+        return _libBornAgainResample.vdouble2d_T_size(self)
 
     def swap(self, v):
-        r"""swap(vdouble2d_t self, vdouble2d_t v)"""
-        return _libBornAgainResample.vdouble2d_t_swap(self, v)
+        r"""swap(vdouble2d_T self, vdouble2d_T v)"""
+        return _libBornAgainResample.vdouble2d_T_swap(self, v)
 
     def begin(self):
-        r"""begin(vdouble2d_t self) -> std::vector< std::vector< double > >::iterator"""
-        return _libBornAgainResample.vdouble2d_t_begin(self)
+        r"""begin(vdouble2d_T self) -> std::vector< std::vector< double > >::iterator"""
+        return _libBornAgainResample.vdouble2d_T_begin(self)
 
     def end(self):
-        r"""end(vdouble2d_t self) -> std::vector< std::vector< double > >::iterator"""
-        return _libBornAgainResample.vdouble2d_t_end(self)
+        r"""end(vdouble2d_T self) -> std::vector< std::vector< double > >::iterator"""
+        return _libBornAgainResample.vdouble2d_T_end(self)
 
     def rbegin(self):
-        r"""rbegin(vdouble2d_t self) -> std::vector< std::vector< double > >::reverse_iterator"""
-        return _libBornAgainResample.vdouble2d_t_rbegin(self)
+        r"""rbegin(vdouble2d_T self) -> std::vector< std::vector< double > >::reverse_iterator"""
+        return _libBornAgainResample.vdouble2d_T_rbegin(self)
 
     def rend(self):
-        r"""rend(vdouble2d_t self) -> std::vector< std::vector< double > >::reverse_iterator"""
-        return _libBornAgainResample.vdouble2d_t_rend(self)
+        r"""rend(vdouble2d_T self) -> std::vector< std::vector< double > >::reverse_iterator"""
+        return _libBornAgainResample.vdouble2d_T_rend(self)
 
     def clear(self):
-        r"""clear(vdouble2d_t self)"""
-        return _libBornAgainResample.vdouble2d_t_clear(self)
+        r"""clear(vdouble2d_T self)"""
+        return _libBornAgainResample.vdouble2d_T_clear(self)
 
     def get_allocator(self):
-        r"""get_allocator(vdouble2d_t self) -> std::vector< std::vector< double > >::allocator_type"""
-        return _libBornAgainResample.vdouble2d_t_get_allocator(self)
+        r"""get_allocator(vdouble2d_T self) -> std::vector< std::vector< double > >::allocator_type"""
+        return _libBornAgainResample.vdouble2d_T_get_allocator(self)
 
     def pop_back(self):
-        r"""pop_back(vdouble2d_t self)"""
-        return _libBornAgainResample.vdouble2d_t_pop_back(self)
+        r"""pop_back(vdouble2d_T self)"""
+        return _libBornAgainResample.vdouble2d_T_pop_back(self)
 
     def erase(self, *args):
         r"""
-        erase(vdouble2d_t self, std::vector< std::vector< double > >::iterator pos) -> std::vector< std::vector< double > >::iterator
-        erase(vdouble2d_t self, std::vector< std::vector< double > >::iterator first, std::vector< std::vector< double > >::iterator last) -> std::vector< std::vector< double > >::iterator
+        erase(vdouble2d_T self, std::vector< std::vector< double > >::iterator pos) -> std::vector< std::vector< double > >::iterator
+        erase(vdouble2d_T self, std::vector< std::vector< double > >::iterator first, std::vector< std::vector< double > >::iterator last) -> std::vector< std::vector< double > >::iterator
         """
-        return _libBornAgainResample.vdouble2d_t_erase(self, *args)
+        return _libBornAgainResample.vdouble2d_T_erase(self, *args)
 
     def __init__(self, *args):
         r"""
-        __init__(vdouble2d_t self) -> vdouble2d_t
-        __init__(vdouble2d_t self, vdouble2d_t other) -> vdouble2d_t
-        __init__(vdouble2d_t self, std::vector< std::vector< double > >::size_type size) -> vdouble2d_t
-        __init__(vdouble2d_t self, std::vector< std::vector< double > >::size_type size, vdouble1d_t value) -> vdouble2d_t
+        __init__(vdouble2d_T self) -> vdouble2d_T
+        __init__(vdouble2d_T self, vdouble2d_T other) -> vdouble2d_T
+        __init__(vdouble2d_T self, std::vector< std::vector< double > >::size_type size) -> vdouble2d_T
+        __init__(vdouble2d_T self, std::vector< std::vector< double > >::size_type size, vdouble1d_T value) -> vdouble2d_T
         """
-        _libBornAgainResample.vdouble2d_t_swiginit(self, _libBornAgainResample.new_vdouble2d_t(*args))
+        _libBornAgainResample.vdouble2d_T_swiginit(self, _libBornAgainResample.new_vdouble2d_T(*args))
 
     def push_back(self, x):
-        r"""push_back(vdouble2d_t self, vdouble1d_t x)"""
-        return _libBornAgainResample.vdouble2d_t_push_back(self, x)
+        r"""push_back(vdouble2d_T self, vdouble1d_T x)"""
+        return _libBornAgainResample.vdouble2d_T_push_back(self, x)
 
     def front(self):
-        r"""front(vdouble2d_t self) -> vdouble1d_t"""
-        return _libBornAgainResample.vdouble2d_t_front(self)
+        r"""front(vdouble2d_T self) -> vdouble1d_T"""
+        return _libBornAgainResample.vdouble2d_T_front(self)
 
     def back(self):
-        r"""back(vdouble2d_t self) -> vdouble1d_t"""
-        return _libBornAgainResample.vdouble2d_t_back(self)
+        r"""back(vdouble2d_T self) -> vdouble1d_T"""
+        return _libBornAgainResample.vdouble2d_T_back(self)
 
     def assign(self, n, x):
-        r"""assign(vdouble2d_t self, std::vector< std::vector< double > >::size_type n, vdouble1d_t x)"""
-        return _libBornAgainResample.vdouble2d_t_assign(self, n, x)
+        r"""assign(vdouble2d_T self, std::vector< std::vector< double > >::size_type n, vdouble1d_T x)"""
+        return _libBornAgainResample.vdouble2d_T_assign(self, n, x)
 
     def resize(self, *args):
         r"""
-        resize(vdouble2d_t self, std::vector< std::vector< double > >::size_type new_size)
-        resize(vdouble2d_t self, std::vector< std::vector< double > >::size_type new_size, vdouble1d_t x)
+        resize(vdouble2d_T self, std::vector< std::vector< double > >::size_type new_size)
+        resize(vdouble2d_T self, std::vector< std::vector< double > >::size_type new_size, vdouble1d_T x)
         """
-        return _libBornAgainResample.vdouble2d_t_resize(self, *args)
+        return _libBornAgainResample.vdouble2d_T_resize(self, *args)
 
     def insert(self, *args):
         r"""
-        insert(vdouble2d_t self, std::vector< std::vector< double > >::iterator pos, vdouble1d_t x) -> std::vector< std::vector< double > >::iterator
-        insert(vdouble2d_t self, std::vector< std::vector< double > >::iterator pos, std::vector< std::vector< double > >::size_type n, vdouble1d_t x)
+        insert(vdouble2d_T self, std::vector< std::vector< double > >::iterator pos, vdouble1d_T x) -> std::vector< std::vector< double > >::iterator
+        insert(vdouble2d_T self, std::vector< std::vector< double > >::iterator pos, std::vector< std::vector< double > >::size_type n, vdouble1d_T x)
         """
-        return _libBornAgainResample.vdouble2d_t_insert(self, *args)
+        return _libBornAgainResample.vdouble2d_T_insert(self, *args)
 
     def reserve(self, n):
-        r"""reserve(vdouble2d_t self, std::vector< std::vector< double > >::size_type n)"""
-        return _libBornAgainResample.vdouble2d_t_reserve(self, n)
+        r"""reserve(vdouble2d_T self, std::vector< std::vector< double > >::size_type n)"""
+        return _libBornAgainResample.vdouble2d_T_reserve(self, n)
 
     def capacity(self):
-        r"""capacity(vdouble2d_t self) -> std::vector< std::vector< double > >::size_type"""
-        return _libBornAgainResample.vdouble2d_t_capacity(self)
-    __swig_destroy__ = _libBornAgainResample.delete_vdouble2d_t
+        r"""capacity(vdouble2d_T self) -> std::vector< std::vector< double > >::size_type"""
+        return _libBornAgainResample.vdouble2d_T_capacity(self)
+    __swig_destroy__ = _libBornAgainResample.delete_vdouble2d_T
 
-# Register vdouble2d_t in _libBornAgainResample:
-_libBornAgainResample.vdouble2d_t_swigregister(vdouble2d_t)
-class vector_integer_t(object):
+# Register vdouble2d_T in _libBornAgainResample:
+_libBornAgainResample.vdouble2d_T_swigregister(vdouble2d_T)
+class vector_integer_T(object):
     r"""Proxy of C++ std::vector< int > class."""
 
     thisown = property(lambda x: x.this.own(), lambda x, v: x.this.own(v), doc="The membership flag")
     __repr__ = _swig_repr
 
     def iterator(self):
-        r"""iterator(vector_integer_t self) -> SwigPyIterator"""
-        return _libBornAgainResample.vector_integer_t_iterator(self)
+        r"""iterator(vector_integer_T self) -> SwigPyIterator"""
+        return _libBornAgainResample.vector_integer_T_iterator(self)
     def __iter__(self):
         return self.iterator()
 
     def __nonzero__(self):
-        r"""__nonzero__(vector_integer_t self) -> bool"""
-        return _libBornAgainResample.vector_integer_t___nonzero__(self)
+        r"""__nonzero__(vector_integer_T self) -> bool"""
+        return _libBornAgainResample.vector_integer_T___nonzero__(self)
 
     def __bool__(self):
-        r"""__bool__(vector_integer_t self) -> bool"""
-        return _libBornAgainResample.vector_integer_t___bool__(self)
+        r"""__bool__(vector_integer_T self) -> bool"""
+        return _libBornAgainResample.vector_integer_T___bool__(self)
 
     def __len__(self):
-        r"""__len__(vector_integer_t self) -> std::vector< int >::size_type"""
-        return _libBornAgainResample.vector_integer_t___len__(self)
+        r"""__len__(vector_integer_T self) -> std::vector< int >::size_type"""
+        return _libBornAgainResample.vector_integer_T___len__(self)
 
     def __getslice__(self, i, j):
-        r"""__getslice__(vector_integer_t self, std::vector< int >::difference_type i, std::vector< int >::difference_type j) -> vector_integer_t"""
-        return _libBornAgainResample.vector_integer_t___getslice__(self, i, j)
+        r"""__getslice__(vector_integer_T self, std::vector< int >::difference_type i, std::vector< int >::difference_type j) -> vector_integer_T"""
+        return _libBornAgainResample.vector_integer_T___getslice__(self, i, j)
 
     def __setslice__(self, *args):
         r"""
-        __setslice__(vector_integer_t self, std::vector< int >::difference_type i, std::vector< int >::difference_type j)
-        __setslice__(vector_integer_t self, std::vector< int >::difference_type i, std::vector< int >::difference_type j, vector_integer_t v)
+        __setslice__(vector_integer_T self, std::vector< int >::difference_type i, std::vector< int >::difference_type j)
+        __setslice__(vector_integer_T self, std::vector< int >::difference_type i, std::vector< int >::difference_type j, vector_integer_T v)
         """
-        return _libBornAgainResample.vector_integer_t___setslice__(self, *args)
+        return _libBornAgainResample.vector_integer_T___setslice__(self, *args)
 
     def __delslice__(self, i, j):
-        r"""__delslice__(vector_integer_t self, std::vector< int >::difference_type i, std::vector< int >::difference_type j)"""
-        return _libBornAgainResample.vector_integer_t___delslice__(self, i, j)
+        r"""__delslice__(vector_integer_T self, std::vector< int >::difference_type i, std::vector< int >::difference_type j)"""
+        return _libBornAgainResample.vector_integer_T___delslice__(self, i, j)
 
     def __delitem__(self, *args):
         r"""
-        __delitem__(vector_integer_t self, std::vector< int >::difference_type i)
-        __delitem__(vector_integer_t self, SWIGPY_SLICEOBJECT * slice)
+        __delitem__(vector_integer_T self, std::vector< int >::difference_type i)
+        __delitem__(vector_integer_T self, SWIGPY_SLICEOBJECT * slice)
         """
-        return _libBornAgainResample.vector_integer_t___delitem__(self, *args)
+        return _libBornAgainResample.vector_integer_T___delitem__(self, *args)
 
     def __getitem__(self, *args):
         r"""
-        __getitem__(vector_integer_t self, SWIGPY_SLICEOBJECT * slice) -> vector_integer_t
-        __getitem__(vector_integer_t self, std::vector< int >::difference_type i) -> std::vector< int >::value_type const &
+        __getitem__(vector_integer_T self, SWIGPY_SLICEOBJECT * slice) -> vector_integer_T
+        __getitem__(vector_integer_T self, std::vector< int >::difference_type i) -> std::vector< int >::value_type const &
         """
-        return _libBornAgainResample.vector_integer_t___getitem__(self, *args)
+        return _libBornAgainResample.vector_integer_T___getitem__(self, *args)
 
     def __setitem__(self, *args):
         r"""
-        __setitem__(vector_integer_t self, SWIGPY_SLICEOBJECT * slice, vector_integer_t v)
-        __setitem__(vector_integer_t self, SWIGPY_SLICEOBJECT * slice)
-        __setitem__(vector_integer_t self, std::vector< int >::difference_type i, std::vector< int >::value_type const & x)
+        __setitem__(vector_integer_T self, SWIGPY_SLICEOBJECT * slice, vector_integer_T v)
+        __setitem__(vector_integer_T self, SWIGPY_SLICEOBJECT * slice)
+        __setitem__(vector_integer_T self, std::vector< int >::difference_type i, std::vector< int >::value_type const & x)
         """
-        return _libBornAgainResample.vector_integer_t___setitem__(self, *args)
+        return _libBornAgainResample.vector_integer_T___setitem__(self, *args)
 
     def pop(self):
-        r"""pop(vector_integer_t self) -> std::vector< int >::value_type"""
-        return _libBornAgainResample.vector_integer_t_pop(self)
+        r"""pop(vector_integer_T self) -> std::vector< int >::value_type"""
+        return _libBornAgainResample.vector_integer_T_pop(self)
 
     def append(self, x):
-        r"""append(vector_integer_t self, std::vector< int >::value_type const & x)"""
-        return _libBornAgainResample.vector_integer_t_append(self, x)
+        r"""append(vector_integer_T self, std::vector< int >::value_type const & x)"""
+        return _libBornAgainResample.vector_integer_T_append(self, x)
 
     def empty(self):
-        r"""empty(vector_integer_t self) -> bool"""
-        return _libBornAgainResample.vector_integer_t_empty(self)
+        r"""empty(vector_integer_T self) -> bool"""
+        return _libBornAgainResample.vector_integer_T_empty(self)
 
     def size(self):
-        r"""size(vector_integer_t self) -> std::vector< int >::size_type"""
-        return _libBornAgainResample.vector_integer_t_size(self)
+        r"""size(vector_integer_T self) -> std::vector< int >::size_type"""
+        return _libBornAgainResample.vector_integer_T_size(self)
 
     def swap(self, v):
-        r"""swap(vector_integer_t self, vector_integer_t v)"""
-        return _libBornAgainResample.vector_integer_t_swap(self, v)
+        r"""swap(vector_integer_T self, vector_integer_T v)"""
+        return _libBornAgainResample.vector_integer_T_swap(self, v)
 
     def begin(self):
-        r"""begin(vector_integer_t self) -> std::vector< int >::iterator"""
-        return _libBornAgainResample.vector_integer_t_begin(self)
+        r"""begin(vector_integer_T self) -> std::vector< int >::iterator"""
+        return _libBornAgainResample.vector_integer_T_begin(self)
 
     def end(self):
-        r"""end(vector_integer_t self) -> std::vector< int >::iterator"""
-        return _libBornAgainResample.vector_integer_t_end(self)
+        r"""end(vector_integer_T self) -> std::vector< int >::iterator"""
+        return _libBornAgainResample.vector_integer_T_end(self)
 
     def rbegin(self):
-        r"""rbegin(vector_integer_t self) -> std::vector< int >::reverse_iterator"""
-        return _libBornAgainResample.vector_integer_t_rbegin(self)
+        r"""rbegin(vector_integer_T self) -> std::vector< int >::reverse_iterator"""
+        return _libBornAgainResample.vector_integer_T_rbegin(self)
 
     def rend(self):
-        r"""rend(vector_integer_t self) -> std::vector< int >::reverse_iterator"""
-        return _libBornAgainResample.vector_integer_t_rend(self)
+        r"""rend(vector_integer_T self) -> std::vector< int >::reverse_iterator"""
+        return _libBornAgainResample.vector_integer_T_rend(self)
 
     def clear(self):
-        r"""clear(vector_integer_t self)"""
-        return _libBornAgainResample.vector_integer_t_clear(self)
+        r"""clear(vector_integer_T self)"""
+        return _libBornAgainResample.vector_integer_T_clear(self)
 
     def get_allocator(self):
-        r"""get_allocator(vector_integer_t self) -> std::vector< int >::allocator_type"""
-        return _libBornAgainResample.vector_integer_t_get_allocator(self)
+        r"""get_allocator(vector_integer_T self) -> std::vector< int >::allocator_type"""
+        return _libBornAgainResample.vector_integer_T_get_allocator(self)
 
     def pop_back(self):
-        r"""pop_back(vector_integer_t self)"""
-        return _libBornAgainResample.vector_integer_t_pop_back(self)
+        r"""pop_back(vector_integer_T self)"""
+        return _libBornAgainResample.vector_integer_T_pop_back(self)
 
     def erase(self, *args):
         r"""
-        erase(vector_integer_t self, std::vector< int >::iterator pos) -> std::vector< int >::iterator
-        erase(vector_integer_t self, std::vector< int >::iterator first, std::vector< int >::iterator last) -> std::vector< int >::iterator
+        erase(vector_integer_T self, std::vector< int >::iterator pos) -> std::vector< int >::iterator
+        erase(vector_integer_T self, std::vector< int >::iterator first, std::vector< int >::iterator last) -> std::vector< int >::iterator
         """
-        return _libBornAgainResample.vector_integer_t_erase(self, *args)
+        return _libBornAgainResample.vector_integer_T_erase(self, *args)
 
     def __init__(self, *args):
         r"""
-        __init__(vector_integer_t self) -> vector_integer_t
-        __init__(vector_integer_t self, vector_integer_t other) -> vector_integer_t
-        __init__(vector_integer_t self, std::vector< int >::size_type size) -> vector_integer_t
-        __init__(vector_integer_t self, std::vector< int >::size_type size, std::vector< int >::value_type const & value) -> vector_integer_t
+        __init__(vector_integer_T self) -> vector_integer_T
+        __init__(vector_integer_T self, vector_integer_T other) -> vector_integer_T
+        __init__(vector_integer_T self, std::vector< int >::size_type size) -> vector_integer_T
+        __init__(vector_integer_T self, std::vector< int >::size_type size, std::vector< int >::value_type const & value) -> vector_integer_T
         """
-        _libBornAgainResample.vector_integer_t_swiginit(self, _libBornAgainResample.new_vector_integer_t(*args))
+        _libBornAgainResample.vector_integer_T_swiginit(self, _libBornAgainResample.new_vector_integer_T(*args))
 
     def push_back(self, x):
-        r"""push_back(vector_integer_t self, std::vector< int >::value_type const & x)"""
-        return _libBornAgainResample.vector_integer_t_push_back(self, x)
+        r"""push_back(vector_integer_T self, std::vector< int >::value_type const & x)"""
+        return _libBornAgainResample.vector_integer_T_push_back(self, x)
 
     def front(self):
-        r"""front(vector_integer_t self) -> std::vector< int >::value_type const &"""
-        return _libBornAgainResample.vector_integer_t_front(self)
+        r"""front(vector_integer_T self) -> std::vector< int >::value_type const &"""
+        return _libBornAgainResample.vector_integer_T_front(self)
 
     def back(self):
-        r"""back(vector_integer_t self) -> std::vector< int >::value_type const &"""
-        return _libBornAgainResample.vector_integer_t_back(self)
+        r"""back(vector_integer_T self) -> std::vector< int >::value_type const &"""
+        return _libBornAgainResample.vector_integer_T_back(self)
 
     def assign(self, n, x):
-        r"""assign(vector_integer_t self, std::vector< int >::size_type n, std::vector< int >::value_type const & x)"""
-        return _libBornAgainResample.vector_integer_t_assign(self, n, x)
+        r"""assign(vector_integer_T self, std::vector< int >::size_type n, std::vector< int >::value_type const & x)"""
+        return _libBornAgainResample.vector_integer_T_assign(self, n, x)
 
     def resize(self, *args):
         r"""
-        resize(vector_integer_t self, std::vector< int >::size_type new_size)
-        resize(vector_integer_t self, std::vector< int >::size_type new_size, std::vector< int >::value_type const & x)
+        resize(vector_integer_T self, std::vector< int >::size_type new_size)
+        resize(vector_integer_T self, std::vector< int >::size_type new_size, std::vector< int >::value_type const & x)
         """
-        return _libBornAgainResample.vector_integer_t_resize(self, *args)
+        return _libBornAgainResample.vector_integer_T_resize(self, *args)
 
     def insert(self, *args):
         r"""
-        insert(vector_integer_t self, std::vector< int >::iterator pos, std::vector< int >::value_type const & x) -> std::vector< int >::iterator
-        insert(vector_integer_t self, std::vector< int >::iterator pos, std::vector< int >::size_type n, std::vector< int >::value_type const & x)
+        insert(vector_integer_T self, std::vector< int >::iterator pos, std::vector< int >::value_type const & x) -> std::vector< int >::iterator
+        insert(vector_integer_T self, std::vector< int >::iterator pos, std::vector< int >::size_type n, std::vector< int >::value_type const & x)
         """
-        return _libBornAgainResample.vector_integer_t_insert(self, *args)
+        return _libBornAgainResample.vector_integer_T_insert(self, *args)
 
     def reserve(self, n):
-        r"""reserve(vector_integer_t self, std::vector< int >::size_type n)"""
-        return _libBornAgainResample.vector_integer_t_reserve(self, n)
+        r"""reserve(vector_integer_T self, std::vector< int >::size_type n)"""
+        return _libBornAgainResample.vector_integer_T_reserve(self, n)
 
     def capacity(self):
-        r"""capacity(vector_integer_t self) -> std::vector< int >::size_type"""
-        return _libBornAgainResample.vector_integer_t_capacity(self)
-    __swig_destroy__ = _libBornAgainResample.delete_vector_integer_t
+        r"""capacity(vector_integer_T self) -> std::vector< int >::size_type"""
+        return _libBornAgainResample.vector_integer_T_capacity(self)
+    __swig_destroy__ = _libBornAgainResample.delete_vector_integer_T
 
-# Register vector_integer_t in _libBornAgainResample:
-_libBornAgainResample.vector_integer_t_swigregister(vector_integer_t)
-class vinteger2d_t(object):
+# Register vector_integer_T in _libBornAgainResample:
+_libBornAgainResample.vector_integer_T_swigregister(vector_integer_T)
+class vinteger2d_T(object):
     r"""Proxy of C++ std::vector< std::vector< int > > class."""
 
     thisown = property(lambda x: x.this.own(), lambda x, v: x.this.own(v), doc="The membership flag")
     __repr__ = _swig_repr
 
     def iterator(self):
-        r"""iterator(vinteger2d_t self) -> SwigPyIterator"""
-        return _libBornAgainResample.vinteger2d_t_iterator(self)
+        r"""iterator(vinteger2d_T self) -> SwigPyIterator"""
+        return _libBornAgainResample.vinteger2d_T_iterator(self)
     def __iter__(self):
         return self.iterator()
 
     def __nonzero__(self):
-        r"""__nonzero__(vinteger2d_t self) -> bool"""
-        return _libBornAgainResample.vinteger2d_t___nonzero__(self)
+        r"""__nonzero__(vinteger2d_T self) -> bool"""
+        return _libBornAgainResample.vinteger2d_T___nonzero__(self)
 
     def __bool__(self):
-        r"""__bool__(vinteger2d_t self) -> bool"""
-        return _libBornAgainResample.vinteger2d_t___bool__(self)
+        r"""__bool__(vinteger2d_T self) -> bool"""
+        return _libBornAgainResample.vinteger2d_T___bool__(self)
 
     def __len__(self):
-        r"""__len__(vinteger2d_t self) -> std::vector< std::vector< int > >::size_type"""
-        return _libBornAgainResample.vinteger2d_t___len__(self)
+        r"""__len__(vinteger2d_T self) -> std::vector< std::vector< int > >::size_type"""
+        return _libBornAgainResample.vinteger2d_T___len__(self)
 
     def __getslice__(self, i, j):
-        r"""__getslice__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j) -> vinteger2d_t"""
-        return _libBornAgainResample.vinteger2d_t___getslice__(self, i, j)
+        r"""__getslice__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j) -> vinteger2d_T"""
+        return _libBornAgainResample.vinteger2d_T___getslice__(self, i, j)
 
     def __setslice__(self, *args):
         r"""
-        __setslice__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j)
-        __setslice__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j, vinteger2d_t v)
+        __setslice__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j)
+        __setslice__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j, vinteger2d_T v)
         """
-        return _libBornAgainResample.vinteger2d_t___setslice__(self, *args)
+        return _libBornAgainResample.vinteger2d_T___setslice__(self, *args)
 
     def __delslice__(self, i, j):
-        r"""__delslice__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j)"""
-        return _libBornAgainResample.vinteger2d_t___delslice__(self, i, j)
+        r"""__delslice__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j)"""
+        return _libBornAgainResample.vinteger2d_T___delslice__(self, i, j)
 
     def __delitem__(self, *args):
         r"""
-        __delitem__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i)
-        __delitem__(vinteger2d_t self, SWIGPY_SLICEOBJECT * slice)
+        __delitem__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i)
+        __delitem__(vinteger2d_T self, SWIGPY_SLICEOBJECT * slice)
         """
-        return _libBornAgainResample.vinteger2d_t___delitem__(self, *args)
+        return _libBornAgainResample.vinteger2d_T___delitem__(self, *args)
 
     def __getitem__(self, *args):
         r"""
-        __getitem__(vinteger2d_t self, SWIGPY_SLICEOBJECT * slice) -> vinteger2d_t
-        __getitem__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i) -> vector_integer_t
+        __getitem__(vinteger2d_T self, SWIGPY_SLICEOBJECT * slice) -> vinteger2d_T
+        __getitem__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i) -> vector_integer_T
         """
-        return _libBornAgainResample.vinteger2d_t___getitem__(self, *args)
+        return _libBornAgainResample.vinteger2d_T___getitem__(self, *args)
 
     def __setitem__(self, *args):
         r"""
-        __setitem__(vinteger2d_t self, SWIGPY_SLICEOBJECT * slice, vinteger2d_t v)
-        __setitem__(vinteger2d_t self, SWIGPY_SLICEOBJECT * slice)
-        __setitem__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i, vector_integer_t x)
+        __setitem__(vinteger2d_T self, SWIGPY_SLICEOBJECT * slice, vinteger2d_T v)
+        __setitem__(vinteger2d_T self, SWIGPY_SLICEOBJECT * slice)
+        __setitem__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i, vector_integer_T x)
         """
-        return _libBornAgainResample.vinteger2d_t___setitem__(self, *args)
+        return _libBornAgainResample.vinteger2d_T___setitem__(self, *args)
 
     def pop(self):
-        r"""pop(vinteger2d_t self) -> vector_integer_t"""
-        return _libBornAgainResample.vinteger2d_t_pop(self)
+        r"""pop(vinteger2d_T self) -> vector_integer_T"""
+        return _libBornAgainResample.vinteger2d_T_pop(self)
 
     def append(self, x):
-        r"""append(vinteger2d_t self, vector_integer_t x)"""
-        return _libBornAgainResample.vinteger2d_t_append(self, x)
+        r"""append(vinteger2d_T self, vector_integer_T x)"""
+        return _libBornAgainResample.vinteger2d_T_append(self, x)
 
     def empty(self):
-        r"""empty(vinteger2d_t self) -> bool"""
-        return _libBornAgainResample.vinteger2d_t_empty(self)
+        r"""empty(vinteger2d_T self) -> bool"""
+        return _libBornAgainResample.vinteger2d_T_empty(self)
 
     def size(self):
-        r"""size(vinteger2d_t self) -> std::vector< std::vector< int > >::size_type"""
-        return _libBornAgainResample.vinteger2d_t_size(self)
+        r"""size(vinteger2d_T self) -> std::vector< std::vector< int > >::size_type"""
+        return _libBornAgainResample.vinteger2d_T_size(self)
 
     def swap(self, v):
-        r"""swap(vinteger2d_t self, vinteger2d_t v)"""
-        return _libBornAgainResample.vinteger2d_t_swap(self, v)
+        r"""swap(vinteger2d_T self, vinteger2d_T v)"""
+        return _libBornAgainResample.vinteger2d_T_swap(self, v)
 
     def begin(self):
-        r"""begin(vinteger2d_t self) -> std::vector< std::vector< int > >::iterator"""
-        return _libBornAgainResample.vinteger2d_t_begin(self)
+        r"""begin(vinteger2d_T self) -> std::vector< std::vector< int > >::iterator"""
+        return _libBornAgainResample.vinteger2d_T_begin(self)
 
     def end(self):
-        r"""end(vinteger2d_t self) -> std::vector< std::vector< int > >::iterator"""
-        return _libBornAgainResample.vinteger2d_t_end(self)
+        r"""end(vinteger2d_T self) -> std::vector< std::vector< int > >::iterator"""
+        return _libBornAgainResample.vinteger2d_T_end(self)
 
     def rbegin(self):
-        r"""rbegin(vinteger2d_t self) -> std::vector< std::vector< int > >::reverse_iterator"""
-        return _libBornAgainResample.vinteger2d_t_rbegin(self)
+        r"""rbegin(vinteger2d_T self) -> std::vector< std::vector< int > >::reverse_iterator"""
+        return _libBornAgainResample.vinteger2d_T_rbegin(self)
 
     def rend(self):
-        r"""rend(vinteger2d_t self) -> std::vector< std::vector< int > >::reverse_iterator"""
-        return _libBornAgainResample.vinteger2d_t_rend(self)
+        r"""rend(vinteger2d_T self) -> std::vector< std::vector< int > >::reverse_iterator"""
+        return _libBornAgainResample.vinteger2d_T_rend(self)
 
     def clear(self):
-        r"""clear(vinteger2d_t self)"""
-        return _libBornAgainResample.vinteger2d_t_clear(self)
+        r"""clear(vinteger2d_T self)"""
+        return _libBornAgainResample.vinteger2d_T_clear(self)
 
     def get_allocator(self):
-        r"""get_allocator(vinteger2d_t self) -> std::vector< std::vector< int > >::allocator_type"""
-        return _libBornAgainResample.vinteger2d_t_get_allocator(self)
+        r"""get_allocator(vinteger2d_T self) -> std::vector< std::vector< int > >::allocator_type"""
+        return _libBornAgainResample.vinteger2d_T_get_allocator(self)
 
     def pop_back(self):
-        r"""pop_back(vinteger2d_t self)"""
-        return _libBornAgainResample.vinteger2d_t_pop_back(self)
+        r"""pop_back(vinteger2d_T self)"""
+        return _libBornAgainResample.vinteger2d_T_pop_back(self)
 
     def erase(self, *args):
         r"""
-        erase(vinteger2d_t self, std::vector< std::vector< int > >::iterator pos) -> std::vector< std::vector< int > >::iterator
-        erase(vinteger2d_t self, std::vector< std::vector< int > >::iterator first, std::vector< std::vector< int > >::iterator last) -> std::vector< std::vector< int > >::iterator
+        erase(vinteger2d_T self, std::vector< std::vector< int > >::iterator pos) -> std::vector< std::vector< int > >::iterator
+        erase(vinteger2d_T self, std::vector< std::vector< int > >::iterator first, std::vector< std::vector< int > >::iterator last) -> std::vector< std::vector< int > >::iterator
         """
-        return _libBornAgainResample.vinteger2d_t_erase(self, *args)
+        return _libBornAgainResample.vinteger2d_T_erase(self, *args)
 
     def __init__(self, *args):
         r"""
-        __init__(vinteger2d_t self) -> vinteger2d_t
-        __init__(vinteger2d_t self, vinteger2d_t other) -> vinteger2d_t
-        __init__(vinteger2d_t self, std::vector< std::vector< int > >::size_type size) -> vinteger2d_t
-        __init__(vinteger2d_t self, std::vector< std::vector< int > >::size_type size, vector_integer_t value) -> vinteger2d_t
+        __init__(vinteger2d_T self) -> vinteger2d_T
+        __init__(vinteger2d_T self, vinteger2d_T other) -> vinteger2d_T
+        __init__(vinteger2d_T self, std::vector< std::vector< int > >::size_type size) -> vinteger2d_T
+        __init__(vinteger2d_T self, std::vector< std::vector< int > >::size_type size, vector_integer_T value) -> vinteger2d_T
         """
-        _libBornAgainResample.vinteger2d_t_swiginit(self, _libBornAgainResample.new_vinteger2d_t(*args))
+        _libBornAgainResample.vinteger2d_T_swiginit(self, _libBornAgainResample.new_vinteger2d_T(*args))
 
     def push_back(self, x):
-        r"""push_back(vinteger2d_t self, vector_integer_t x)"""
-        return _libBornAgainResample.vinteger2d_t_push_back(self, x)
+        r"""push_back(vinteger2d_T self, vector_integer_T x)"""
+        return _libBornAgainResample.vinteger2d_T_push_back(self, x)
 
     def front(self):
-        r"""front(vinteger2d_t self) -> vector_integer_t"""
-        return _libBornAgainResample.vinteger2d_t_front(self)
+        r"""front(vinteger2d_T self) -> vector_integer_T"""
+        return _libBornAgainResample.vinteger2d_T_front(self)
 
     def back(self):
-        r"""back(vinteger2d_t self) -> vector_integer_t"""
-        return _libBornAgainResample.vinteger2d_t_back(self)
+        r"""back(vinteger2d_T self) -> vector_integer_T"""
+        return _libBornAgainResample.vinteger2d_T_back(self)
 
     def assign(self, n, x):
-        r"""assign(vinteger2d_t self, std::vector< std::vector< int > >::size_type n, vector_integer_t x)"""
-        return _libBornAgainResample.vinteger2d_t_assign(self, n, x)
+        r"""assign(vinteger2d_T self, std::vector< std::vector< int > >::size_type n, vector_integer_T x)"""
+        return _libBornAgainResample.vinteger2d_T_assign(self, n, x)
 
     def resize(self, *args):
         r"""
-        resize(vinteger2d_t self, std::vector< std::vector< int > >::size_type new_size)
-        resize(vinteger2d_t self, std::vector< std::vector< int > >::size_type new_size, vector_integer_t x)
+        resize(vinteger2d_T self, std::vector< std::vector< int > >::size_type new_size)
+        resize(vinteger2d_T self, std::vector< std::vector< int > >::size_type new_size, vector_integer_T x)
         """
-        return _libBornAgainResample.vinteger2d_t_resize(self, *args)
+        return _libBornAgainResample.vinteger2d_T_resize(self, *args)
 
     def insert(self, *args):
         r"""
-        insert(vinteger2d_t self, std::vector< std::vector< int > >::iterator pos, vector_integer_t x) -> std::vector< std::vector< int > >::iterator
-        insert(vinteger2d_t self, std::vector< std::vector< int > >::iterator pos, std::vector< std::vector< int > >::size_type n, vector_integer_t x)
+        insert(vinteger2d_T self, std::vector< std::vector< int > >::iterator pos, vector_integer_T x) -> std::vector< std::vector< int > >::iterator
+        insert(vinteger2d_T self, std::vector< std::vector< int > >::iterator pos, std::vector< std::vector< int > >::size_type n, vector_integer_T x)
         """
-        return _libBornAgainResample.vinteger2d_t_insert(self, *args)
+        return _libBornAgainResample.vinteger2d_T_insert(self, *args)
 
     def reserve(self, n):
-        r"""reserve(vinteger2d_t self, std::vector< std::vector< int > >::size_type n)"""
-        return _libBornAgainResample.vinteger2d_t_reserve(self, n)
+        r"""reserve(vinteger2d_T self, std::vector< std::vector< int > >::size_type n)"""
+        return _libBornAgainResample.vinteger2d_T_reserve(self, n)
 
     def capacity(self):
-        r"""capacity(vinteger2d_t self) -> std::vector< std::vector< int > >::size_type"""
-        return _libBornAgainResample.vinteger2d_t_capacity(self)
-    __swig_destroy__ = _libBornAgainResample.delete_vinteger2d_t
+        r"""capacity(vinteger2d_T self) -> std::vector< std::vector< int > >::size_type"""
+        return _libBornAgainResample.vinteger2d_T_capacity(self)
+    __swig_destroy__ = _libBornAgainResample.delete_vinteger2d_T
 
-# Register vinteger2d_t in _libBornAgainResample:
-_libBornAgainResample.vinteger2d_t_swigregister(vinteger2d_t)
-class vector_longinteger_t(object):
+# Register vinteger2d_T in _libBornAgainResample:
+_libBornAgainResample.vinteger2d_T_swigregister(vinteger2d_T)
+class vector_longinteger_T(object):
     r"""Proxy of C++ std::vector< unsigned long > class."""
 
     thisown = property(lambda x: x.this.own(), lambda x, v: x.this.own(v), doc="The membership flag")
     __repr__ = _swig_repr
 
     def iterator(self):
-        r"""iterator(vector_longinteger_t self) -> SwigPyIterator"""
-        return _libBornAgainResample.vector_longinteger_t_iterator(self)
+        r"""iterator(vector_longinteger_T self) -> SwigPyIterator"""
+        return _libBornAgainResample.vector_longinteger_T_iterator(self)
     def __iter__(self):
         return self.iterator()
 
     def __nonzero__(self):
-        r"""__nonzero__(vector_longinteger_t self) -> bool"""
-        return _libBornAgainResample.vector_longinteger_t___nonzero__(self)
+        r"""__nonzero__(vector_longinteger_T self) -> bool"""
+        return _libBornAgainResample.vector_longinteger_T___nonzero__(self)
 
     def __bool__(self):
-        r"""__bool__(vector_longinteger_t self) -> bool"""
-        return _libBornAgainResample.vector_longinteger_t___bool__(self)
+        r"""__bool__(vector_longinteger_T self) -> bool"""
+        return _libBornAgainResample.vector_longinteger_T___bool__(self)
 
     def __len__(self):
-        r"""__len__(vector_longinteger_t self) -> std::vector< unsigned long >::size_type"""
-        return _libBornAgainResample.vector_longinteger_t___len__(self)
+        r"""__len__(vector_longinteger_T self) -> std::vector< unsigned long >::size_type"""
+        return _libBornAgainResample.vector_longinteger_T___len__(self)
 
     def __getslice__(self, i, j):
-        r"""__getslice__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j) -> vector_longinteger_t"""
-        return _libBornAgainResample.vector_longinteger_t___getslice__(self, i, j)
+        r"""__getslice__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j) -> vector_longinteger_T"""
+        return _libBornAgainResample.vector_longinteger_T___getslice__(self, i, j)
 
     def __setslice__(self, *args):
         r"""
-        __setslice__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j)
-        __setslice__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j, vector_longinteger_t v)
+        __setslice__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j)
+        __setslice__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j, vector_longinteger_T v)
         """
-        return _libBornAgainResample.vector_longinteger_t___setslice__(self, *args)
+        return _libBornAgainResample.vector_longinteger_T___setslice__(self, *args)
 
     def __delslice__(self, i, j):
-        r"""__delslice__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j)"""
-        return _libBornAgainResample.vector_longinteger_t___delslice__(self, i, j)
+        r"""__delslice__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j)"""
+        return _libBornAgainResample.vector_longinteger_T___delslice__(self, i, j)
 
     def __delitem__(self, *args):
         r"""
-        __delitem__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i)
-        __delitem__(vector_longinteger_t self, SWIGPY_SLICEOBJECT * slice)
+        __delitem__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i)
+        __delitem__(vector_longinteger_T self, SWIGPY_SLICEOBJECT * slice)
         """
-        return _libBornAgainResample.vector_longinteger_t___delitem__(self, *args)
+        return _libBornAgainResample.vector_longinteger_T___delitem__(self, *args)
 
     def __getitem__(self, *args):
         r"""
-        __getitem__(vector_longinteger_t self, SWIGPY_SLICEOBJECT * slice) -> vector_longinteger_t
-        __getitem__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i) -> std::vector< unsigned long >::value_type const &
+        __getitem__(vector_longinteger_T self, SWIGPY_SLICEOBJECT * slice) -> vector_longinteger_T
+        __getitem__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i) -> std::vector< unsigned long >::value_type const &
         """
-        return _libBornAgainResample.vector_longinteger_t___getitem__(self, *args)
+        return _libBornAgainResample.vector_longinteger_T___getitem__(self, *args)
 
     def __setitem__(self, *args):
         r"""
-        __setitem__(vector_longinteger_t self, SWIGPY_SLICEOBJECT * slice, vector_longinteger_t v)
-        __setitem__(vector_longinteger_t self, SWIGPY_SLICEOBJECT * slice)
-        __setitem__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::value_type const & x)
+        __setitem__(vector_longinteger_T self, SWIGPY_SLICEOBJECT * slice, vector_longinteger_T v)
+        __setitem__(vector_longinteger_T self, SWIGPY_SLICEOBJECT * slice)
+        __setitem__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::value_type const & x)
         """
-        return _libBornAgainResample.vector_longinteger_t___setitem__(self, *args)
+        return _libBornAgainResample.vector_longinteger_T___setitem__(self, *args)
 
     def pop(self):
-        r"""pop(vector_longinteger_t self) -> std::vector< unsigned long >::value_type"""
-        return _libBornAgainResample.vector_longinteger_t_pop(self)
+        r"""pop(vector_longinteger_T self) -> std::vector< unsigned long >::value_type"""
+        return _libBornAgainResample.vector_longinteger_T_pop(self)
 
     def append(self, x):
-        r"""append(vector_longinteger_t self, std::vector< unsigned long >::value_type const & x)"""
-        return _libBornAgainResample.vector_longinteger_t_append(self, x)
+        r"""append(vector_longinteger_T self, std::vector< unsigned long >::value_type const & x)"""
+        return _libBornAgainResample.vector_longinteger_T_append(self, x)
 
     def empty(self):
-        r"""empty(vector_longinteger_t self) -> bool"""
-        return _libBornAgainResample.vector_longinteger_t_empty(self)
+        r"""empty(vector_longinteger_T self) -> bool"""
+        return _libBornAgainResample.vector_longinteger_T_empty(self)
 
     def size(self):
-        r"""size(vector_longinteger_t self) -> std::vector< unsigned long >::size_type"""
-        return _libBornAgainResample.vector_longinteger_t_size(self)
+        r"""size(vector_longinteger_T self) -> std::vector< unsigned long >::size_type"""
+        return _libBornAgainResample.vector_longinteger_T_size(self)
 
     def swap(self, v):
-        r"""swap(vector_longinteger_t self, vector_longinteger_t v)"""
-        return _libBornAgainResample.vector_longinteger_t_swap(self, v)
+        r"""swap(vector_longinteger_T self, vector_longinteger_T v)"""
+        return _libBornAgainResample.vector_longinteger_T_swap(self, v)
 
     def begin(self):
-        r"""begin(vector_longinteger_t self) -> std::vector< unsigned long >::iterator"""
-        return _libBornAgainResample.vector_longinteger_t_begin(self)
+        r"""begin(vector_longinteger_T self) -> std::vector< unsigned long >::iterator"""
+        return _libBornAgainResample.vector_longinteger_T_begin(self)
 
     def end(self):
-        r"""end(vector_longinteger_t self) -> std::vector< unsigned long >::iterator"""
-        return _libBornAgainResample.vector_longinteger_t_end(self)
+        r"""end(vector_longinteger_T self) -> std::vector< unsigned long >::iterator"""
+        return _libBornAgainResample.vector_longinteger_T_end(self)
 
     def rbegin(self):
-        r"""rbegin(vector_longinteger_t self) -> std::vector< unsigned long >::reverse_iterator"""
-        return _libBornAgainResample.vector_longinteger_t_rbegin(self)
+        r"""rbegin(vector_longinteger_T self) -> std::vector< unsigned long >::reverse_iterator"""
+        return _libBornAgainResample.vector_longinteger_T_rbegin(self)
 
     def rend(self):
-        r"""rend(vector_longinteger_t self) -> std::vector< unsigned long >::reverse_iterator"""
-        return _libBornAgainResample.vector_longinteger_t_rend(self)
+        r"""rend(vector_longinteger_T self) -> std::vector< unsigned long >::reverse_iterator"""
+        return _libBornAgainResample.vector_longinteger_T_rend(self)
 
     def clear(self):
-        r"""clear(vector_longinteger_t self)"""
-        return _libBornAgainResample.vector_longinteger_t_clear(self)
+        r"""clear(vector_longinteger_T self)"""
+        return _libBornAgainResample.vector_longinteger_T_clear(self)
 
     def get_allocator(self):
-        r"""get_allocator(vector_longinteger_t self) -> std::vector< unsigned long >::allocator_type"""
-        return _libBornAgainResample.vector_longinteger_t_get_allocator(self)
+        r"""get_allocator(vector_longinteger_T self) -> std::vector< unsigned long >::allocator_type"""
+        return _libBornAgainResample.vector_longinteger_T_get_allocator(self)
 
     def pop_back(self):
-        r"""pop_back(vector_longinteger_t self)"""
-        return _libBornAgainResample.vector_longinteger_t_pop_back(self)
+        r"""pop_back(vector_longinteger_T self)"""
+        return _libBornAgainResample.vector_longinteger_T_pop_back(self)
 
     def erase(self, *args):
         r"""
-        erase(vector_longinteger_t self, std::vector< unsigned long >::iterator pos) -> std::vector< unsigned long >::iterator
-        erase(vector_longinteger_t self, std::vector< unsigned long >::iterator first, std::vector< unsigned long >::iterator last) -> std::vector< unsigned long >::iterator
+        erase(vector_longinteger_T self, std::vector< unsigned long >::iterator pos) -> std::vector< unsigned long >::iterator
+        erase(vector_longinteger_T self, std::vector< unsigned long >::iterator first, std::vector< unsigned long >::iterator last) -> std::vector< unsigned long >::iterator
         """
-        return _libBornAgainResample.vector_longinteger_t_erase(self, *args)
+        return _libBornAgainResample.vector_longinteger_T_erase(self, *args)
 
     def __init__(self, *args):
         r"""
-        __init__(vector_longinteger_t self) -> vector_longinteger_t
-        __init__(vector_longinteger_t self, vector_longinteger_t other) -> vector_longinteger_t
-        __init__(vector_longinteger_t self, std::vector< unsigned long >::size_type size) -> vector_longinteger_t
-        __init__(vector_longinteger_t self, std::vector< unsigned long >::size_type size, std::vector< unsigned long >::value_type const & value) -> vector_longinteger_t
+        __init__(vector_longinteger_T self) -> vector_longinteger_T
+        __init__(vector_longinteger_T self, vector_longinteger_T other) -> vector_longinteger_T
+        __init__(vector_longinteger_T self, std::vector< unsigned long >::size_type size) -> vector_longinteger_T
+        __init__(vector_longinteger_T self, std::vector< unsigned long >::size_type size, std::vector< unsigned long >::value_type const & value) -> vector_longinteger_T
         """
-        _libBornAgainResample.vector_longinteger_t_swiginit(self, _libBornAgainResample.new_vector_longinteger_t(*args))
+        _libBornAgainResample.vector_longinteger_T_swiginit(self, _libBornAgainResample.new_vector_longinteger_T(*args))
 
     def push_back(self, x):
-        r"""push_back(vector_longinteger_t self, std::vector< unsigned long >::value_type const & x)"""
-        return _libBornAgainResample.vector_longinteger_t_push_back(self, x)
+        r"""push_back(vector_longinteger_T self, std::vector< unsigned long >::value_type const & x)"""
+        return _libBornAgainResample.vector_longinteger_T_push_back(self, x)
 
     def front(self):
-        r"""front(vector_longinteger_t self) -> std::vector< unsigned long >::value_type const &"""
-        return _libBornAgainResample.vector_longinteger_t_front(self)
+        r"""front(vector_longinteger_T self) -> std::vector< unsigned long >::value_type const &"""
+        return _libBornAgainResample.vector_longinteger_T_front(self)
 
     def back(self):
-        r"""back(vector_longinteger_t self) -> std::vector< unsigned long >::value_type const &"""
-        return _libBornAgainResample.vector_longinteger_t_back(self)
+        r"""back(vector_longinteger_T self) -> std::vector< unsigned long >::value_type const &"""
+        return _libBornAgainResample.vector_longinteger_T_back(self)
 
     def assign(self, n, x):
-        r"""assign(vector_longinteger_t self, std::vector< unsigned long >::size_type n, std::vector< unsigned long >::value_type const & x)"""
-        return _libBornAgainResample.vector_longinteger_t_assign(self, n, x)
+        r"""assign(vector_longinteger_T self, std::vector< unsigned long >::size_type n, std::vector< unsigned long >::value_type const & x)"""
+        return _libBornAgainResample.vector_longinteger_T_assign(self, n, x)
 
     def resize(self, *args):
         r"""
-        resize(vector_longinteger_t self, std::vector< unsigned long >::size_type new_size)
-        resize(vector_longinteger_t self, std::vector< unsigned long >::size_type new_size, std::vector< unsigned long >::value_type const & x)
+        resize(vector_longinteger_T self, std::vector< unsigned long >::size_type new_size)
+        resize(vector_longinteger_T self, std::vector< unsigned long >::size_type new_size, std::vector< unsigned long >::value_type const & x)
         """
-        return _libBornAgainResample.vector_longinteger_t_resize(self, *args)
+        return _libBornAgainResample.vector_longinteger_T_resize(self, *args)
 
     def insert(self, *args):
         r"""
-        insert(vector_longinteger_t self, std::vector< unsigned long >::iterator pos, std::vector< unsigned long >::value_type const & x) -> std::vector< unsigned long >::iterator
-        insert(vector_longinteger_t self, std::vector< unsigned long >::iterator pos, std::vector< unsigned long >::size_type n, std::vector< unsigned long >::value_type const & x)
+        insert(vector_longinteger_T self, std::vector< unsigned long >::iterator pos, std::vector< unsigned long >::value_type const & x) -> std::vector< unsigned long >::iterator
+        insert(vector_longinteger_T self, std::vector< unsigned long >::iterator pos, std::vector< unsigned long >::size_type n, std::vector< unsigned long >::value_type const & x)
         """
-        return _libBornAgainResample.vector_longinteger_t_insert(self, *args)
+        return _libBornAgainResample.vector_longinteger_T_insert(self, *args)
 
     def reserve(self, n):
-        r"""reserve(vector_longinteger_t self, std::vector< unsigned long >::size_type n)"""
-        return _libBornAgainResample.vector_longinteger_t_reserve(self, n)
+        r"""reserve(vector_longinteger_T self, std::vector< unsigned long >::size_type n)"""
+        return _libBornAgainResample.vector_longinteger_T_reserve(self, n)
 
     def capacity(self):
-        r"""capacity(vector_longinteger_t self) -> std::vector< unsigned long >::size_type"""
-        return _libBornAgainResample.vector_longinteger_t_capacity(self)
-    __swig_destroy__ = _libBornAgainResample.delete_vector_longinteger_t
+        r"""capacity(vector_longinteger_T self) -> std::vector< unsigned long >::size_type"""
+        return _libBornAgainResample.vector_longinteger_T_capacity(self)
+    __swig_destroy__ = _libBornAgainResample.delete_vector_longinteger_T
 
-# Register vector_longinteger_t in _libBornAgainResample:
-_libBornAgainResample.vector_longinteger_t_swigregister(vector_longinteger_t)
-class vector_complex_t(object):
+# Register vector_longinteger_T in _libBornAgainResample:
+_libBornAgainResample.vector_longinteger_T_swigregister(vector_longinteger_T)
+class vector_complex_T(object):
     r"""Proxy of C++ std::vector< std::complex< double > > class."""
 
     thisown = property(lambda x: x.this.own(), lambda x, v: x.this.own(v), doc="The membership flag")
     __repr__ = _swig_repr
 
     def iterator(self):
-        r"""iterator(vector_complex_t self) -> SwigPyIterator"""
-        return _libBornAgainResample.vector_complex_t_iterator(self)
+        r"""iterator(vector_complex_T self) -> SwigPyIterator"""
+        return _libBornAgainResample.vector_complex_T_iterator(self)
     def __iter__(self):
         return self.iterator()
 
     def __nonzero__(self):
-        r"""__nonzero__(vector_complex_t self) -> bool"""
-        return _libBornAgainResample.vector_complex_t___nonzero__(self)
+        r"""__nonzero__(vector_complex_T self) -> bool"""
+        return _libBornAgainResample.vector_complex_T___nonzero__(self)
 
     def __bool__(self):
-        r"""__bool__(vector_complex_t self) -> bool"""
-        return _libBornAgainResample.vector_complex_t___bool__(self)
+        r"""__bool__(vector_complex_T self) -> bool"""
+        return _libBornAgainResample.vector_complex_T___bool__(self)
 
     def __len__(self):
-        r"""__len__(vector_complex_t self) -> std::vector< std::complex< double > >::size_type"""
-        return _libBornAgainResample.vector_complex_t___len__(self)
+        r"""__len__(vector_complex_T self) -> std::vector< std::complex< double > >::size_type"""
+        return _libBornAgainResample.vector_complex_T___len__(self)
 
     def __getslice__(self, i, j):
-        r"""__getslice__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j) -> vector_complex_t"""
-        return _libBornAgainResample.vector_complex_t___getslice__(self, i, j)
+        r"""__getslice__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j) -> vector_complex_T"""
+        return _libBornAgainResample.vector_complex_T___getslice__(self, i, j)
 
     def __setslice__(self, *args):
         r"""
-        __setslice__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j)
-        __setslice__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j, vector_complex_t v)
+        __setslice__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j)
+        __setslice__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j, vector_complex_T v)
         """
-        return _libBornAgainResample.vector_complex_t___setslice__(self, *args)
+        return _libBornAgainResample.vector_complex_T___setslice__(self, *args)
 
     def __delslice__(self, i, j):
-        r"""__delslice__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j)"""
-        return _libBornAgainResample.vector_complex_t___delslice__(self, i, j)
+        r"""__delslice__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j)"""
+        return _libBornAgainResample.vector_complex_T___delslice__(self, i, j)
 
     def __delitem__(self, *args):
         r"""
-        __delitem__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i)
-        __delitem__(vector_complex_t self, SWIGPY_SLICEOBJECT * slice)
+        __delitem__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i)
+        __delitem__(vector_complex_T self, SWIGPY_SLICEOBJECT * slice)
         """
-        return _libBornAgainResample.vector_complex_t___delitem__(self, *args)
+        return _libBornAgainResample.vector_complex_T___delitem__(self, *args)
 
     def __getitem__(self, *args):
         r"""
-        __getitem__(vector_complex_t self, SWIGPY_SLICEOBJECT * slice) -> vector_complex_t
-        __getitem__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i) -> std::vector< std::complex< double > >::value_type const &
+        __getitem__(vector_complex_T self, SWIGPY_SLICEOBJECT * slice) -> vector_complex_T
+        __getitem__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i) -> std::vector< std::complex< double > >::value_type const &
         """
-        return _libBornAgainResample.vector_complex_t___getitem__(self, *args)
+        return _libBornAgainResample.vector_complex_T___getitem__(self, *args)
 
     def __setitem__(self, *args):
         r"""
-        __setitem__(vector_complex_t self, SWIGPY_SLICEOBJECT * slice, vector_complex_t v)
-        __setitem__(vector_complex_t self, SWIGPY_SLICEOBJECT * slice)
-        __setitem__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::value_type const & x)
+        __setitem__(vector_complex_T self, SWIGPY_SLICEOBJECT * slice, vector_complex_T v)
+        __setitem__(vector_complex_T self, SWIGPY_SLICEOBJECT * slice)
+        __setitem__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::value_type const & x)
         """
-        return _libBornAgainResample.vector_complex_t___setitem__(self, *args)
+        return _libBornAgainResample.vector_complex_T___setitem__(self, *args)
 
     def pop(self):
-        r"""pop(vector_complex_t self) -> std::vector< std::complex< double > >::value_type"""
-        return _libBornAgainResample.vector_complex_t_pop(self)
+        r"""pop(vector_complex_T self) -> std::vector< std::complex< double > >::value_type"""
+        return _libBornAgainResample.vector_complex_T_pop(self)
 
     def append(self, x):
-        r"""append(vector_complex_t self, std::vector< std::complex< double > >::value_type const & x)"""
-        return _libBornAgainResample.vector_complex_t_append(self, x)
+        r"""append(vector_complex_T self, std::vector< std::complex< double > >::value_type const & x)"""
+        return _libBornAgainResample.vector_complex_T_append(self, x)
 
     def empty(self):
-        r"""empty(vector_complex_t self) -> bool"""
-        return _libBornAgainResample.vector_complex_t_empty(self)
+        r"""empty(vector_complex_T self) -> bool"""
+        return _libBornAgainResample.vector_complex_T_empty(self)
 
     def size(self):
-        r"""size(vector_complex_t self) -> std::vector< std::complex< double > >::size_type"""
-        return _libBornAgainResample.vector_complex_t_size(self)
+        r"""size(vector_complex_T self) -> std::vector< std::complex< double > >::size_type"""
+        return _libBornAgainResample.vector_complex_T_size(self)
 
     def swap(self, v):
-        r"""swap(vector_complex_t self, vector_complex_t v)"""
-        return _libBornAgainResample.vector_complex_t_swap(self, v)
+        r"""swap(vector_complex_T self, vector_complex_T v)"""
+        return _libBornAgainResample.vector_complex_T_swap(self, v)
 
     def begin(self):
-        r"""begin(vector_complex_t self) -> std::vector< std::complex< double > >::iterator"""
-        return _libBornAgainResample.vector_complex_t_begin(self)
+        r"""begin(vector_complex_T self) -> std::vector< std::complex< double > >::iterator"""
+        return _libBornAgainResample.vector_complex_T_begin(self)
 
     def end(self):
-        r"""end(vector_complex_t self) -> std::vector< std::complex< double > >::iterator"""
-        return _libBornAgainResample.vector_complex_t_end(self)
+        r"""end(vector_complex_T self) -> std::vector< std::complex< double > >::iterator"""
+        return _libBornAgainResample.vector_complex_T_end(self)
 
     def rbegin(self):
-        r"""rbegin(vector_complex_t self) -> std::vector< std::complex< double > >::reverse_iterator"""
-        return _libBornAgainResample.vector_complex_t_rbegin(self)
+        r"""rbegin(vector_complex_T self) -> std::vector< std::complex< double > >::reverse_iterator"""
+        return _libBornAgainResample.vector_complex_T_rbegin(self)
 
     def rend(self):
-        r"""rend(vector_complex_t self) -> std::vector< std::complex< double > >::reverse_iterator"""
-        return _libBornAgainResample.vector_complex_t_rend(self)
+        r"""rend(vector_complex_T self) -> std::vector< std::complex< double > >::reverse_iterator"""
+        return _libBornAgainResample.vector_complex_T_rend(self)
 
     def clear(self):
-        r"""clear(vector_complex_t self)"""
-        return _libBornAgainResample.vector_complex_t_clear(self)
+        r"""clear(vector_complex_T self)"""
+        return _libBornAgainResample.vector_complex_T_clear(self)
 
     def get_allocator(self):
-        r"""get_allocator(vector_complex_t self) -> std::vector< std::complex< double > >::allocator_type"""
-        return _libBornAgainResample.vector_complex_t_get_allocator(self)
+        r"""get_allocator(vector_complex_T self) -> std::vector< std::complex< double > >::allocator_type"""
+        return _libBornAgainResample.vector_complex_T_get_allocator(self)
 
     def pop_back(self):
-        r"""pop_back(vector_complex_t self)"""
-        return _libBornAgainResample.vector_complex_t_pop_back(self)
+        r"""pop_back(vector_complex_T self)"""
+        return _libBornAgainResample.vector_complex_T_pop_back(self)
 
     def erase(self, *args):
         r"""
-        erase(vector_complex_t self, std::vector< std::complex< double > >::iterator pos) -> std::vector< std::complex< double > >::iterator
-        erase(vector_complex_t self, std::vector< std::complex< double > >::iterator first, std::vector< std::complex< double > >::iterator last) -> std::vector< std::complex< double > >::iterator
+        erase(vector_complex_T self, std::vector< std::complex< double > >::iterator pos) -> std::vector< std::complex< double > >::iterator
+        erase(vector_complex_T self, std::vector< std::complex< double > >::iterator first, std::vector< std::complex< double > >::iterator last) -> std::vector< std::complex< double > >::iterator
         """
-        return _libBornAgainResample.vector_complex_t_erase(self, *args)
+        return _libBornAgainResample.vector_complex_T_erase(self, *args)
 
     def __init__(self, *args):
         r"""
-        __init__(vector_complex_t self) -> vector_complex_t
-        __init__(vector_complex_t self, vector_complex_t other) -> vector_complex_t
-        __init__(vector_complex_t self, std::vector< std::complex< double > >::size_type size) -> vector_complex_t
-        __init__(vector_complex_t self, std::vector< std::complex< double > >::size_type size, std::vector< std::complex< double > >::value_type const & value) -> vector_complex_t
+        __init__(vector_complex_T self) -> vector_complex_T
+        __init__(vector_complex_T self, vector_complex_T other) -> vector_complex_T
+        __init__(vector_complex_T self, std::vector< std::complex< double > >::size_type size) -> vector_complex_T
+        __init__(vector_complex_T self, std::vector< std::complex< double > >::size_type size, std::vector< std::complex< double > >::value_type const & value) -> vector_complex_T
         """
-        _libBornAgainResample.vector_complex_t_swiginit(self, _libBornAgainResample.new_vector_complex_t(*args))
+        _libBornAgainResample.vector_complex_T_swiginit(self, _libBornAgainResample.new_vector_complex_T(*args))
 
     def push_back(self, x):
-        r"""push_back(vector_complex_t self, std::vector< std::complex< double > >::value_type const & x)"""
-        return _libBornAgainResample.vector_complex_t_push_back(self, x)
+        r"""push_back(vector_complex_T self, std::vector< std::complex< double > >::value_type const & x)"""
+        return _libBornAgainResample.vector_complex_T_push_back(self, x)
 
     def front(self):
-        r"""front(vector_complex_t self) -> std::vector< std::complex< double > >::value_type const &"""
-        return _libBornAgainResample.vector_complex_t_front(self)
+        r"""front(vector_complex_T self) -> std::vector< std::complex< double > >::value_type const &"""
+        return _libBornAgainResample.vector_complex_T_front(self)
 
     def back(self):
-        r"""back(vector_complex_t self) -> std::vector< std::complex< double > >::value_type const &"""
-        return _libBornAgainResample.vector_complex_t_back(self)
+        r"""back(vector_complex_T self) -> std::vector< std::complex< double > >::value_type const &"""
+        return _libBornAgainResample.vector_complex_T_back(self)
 
     def assign(self, n, x):
-        r"""assign(vector_complex_t self, std::vector< std::complex< double > >::size_type n, std::vector< std::complex< double > >::value_type const & x)"""
-        return _libBornAgainResample.vector_complex_t_assign(self, n, x)
+        r"""assign(vector_complex_T self, std::vector< std::complex< double > >::size_type n, std::vector< std::complex< double > >::value_type const & x)"""
+        return _libBornAgainResample.vector_complex_T_assign(self, n, x)
 
     def resize(self, *args):
         r"""
-        resize(vector_complex_t self, std::vector< std::complex< double > >::size_type new_size)
-        resize(vector_complex_t self, std::vector< std::complex< double > >::size_type new_size, std::vector< std::complex< double > >::value_type const & x)
+        resize(vector_complex_T self, std::vector< std::complex< double > >::size_type new_size)
+        resize(vector_complex_T self, std::vector< std::complex< double > >::size_type new_size, std::vector< std::complex< double > >::value_type const & x)
         """
-        return _libBornAgainResample.vector_complex_t_resize(self, *args)
+        return _libBornAgainResample.vector_complex_T_resize(self, *args)
 
     def insert(self, *args):
         r"""
-        insert(vector_complex_t self, std::vector< std::complex< double > >::iterator pos, std::vector< std::complex< double > >::value_type const & x) -> std::vector< std::complex< double > >::iterator
-        insert(vector_complex_t self, std::vector< std::complex< double > >::iterator pos, std::vector< std::complex< double > >::size_type n, std::vector< std::complex< double > >::value_type const & x)
+        insert(vector_complex_T self, std::vector< std::complex< double > >::iterator pos, std::vector< std::complex< double > >::value_type const & x) -> std::vector< std::complex< double > >::iterator
+        insert(vector_complex_T self, std::vector< std::complex< double > >::iterator pos, std::vector< std::complex< double > >::size_type n, std::vector< std::complex< double > >::value_type const & x)
         """
-        return _libBornAgainResample.vector_complex_t_insert(self, *args)
+        return _libBornAgainResample.vector_complex_T_insert(self, *args)
 
     def reserve(self, n):
-        r"""reserve(vector_complex_t self, std::vector< std::complex< double > >::size_type n)"""
-        return _libBornAgainResample.vector_complex_t_reserve(self, n)
+        r"""reserve(vector_complex_T self, std::vector< std::complex< double > >::size_type n)"""
+        return _libBornAgainResample.vector_complex_T_reserve(self, n)
 
     def capacity(self):
-        r"""capacity(vector_complex_t self) -> std::vector< std::complex< double > >::size_type"""
-        return _libBornAgainResample.vector_complex_t_capacity(self)
-    __swig_destroy__ = _libBornAgainResample.delete_vector_complex_t
+        r"""capacity(vector_complex_T self) -> std::vector< std::complex< double > >::size_type"""
+        return _libBornAgainResample.vector_complex_T_capacity(self)
+    __swig_destroy__ = _libBornAgainResample.delete_vector_complex_T
 
-# Register vector_complex_t in _libBornAgainResample:
-_libBornAgainResample.vector_complex_t_swigregister(vector_complex_t)
-class vector_string_t(object):
+# Register vector_complex_T in _libBornAgainResample:
+_libBornAgainResample.vector_complex_T_swigregister(vector_complex_T)
+class vector_string_T(object):
     r"""Proxy of C++ std::vector< std::string > class."""
 
     thisown = property(lambda x: x.this.own(), lambda x, v: x.this.own(v), doc="The membership flag")
     __repr__ = _swig_repr
 
     def iterator(self):
-        r"""iterator(vector_string_t self) -> SwigPyIterator"""
-        return _libBornAgainResample.vector_string_t_iterator(self)
+        r"""iterator(vector_string_T self) -> SwigPyIterator"""
+        return _libBornAgainResample.vector_string_T_iterator(self)
     def __iter__(self):
         return self.iterator()
 
     def __nonzero__(self):
-        r"""__nonzero__(vector_string_t self) -> bool"""
-        return _libBornAgainResample.vector_string_t___nonzero__(self)
+        r"""__nonzero__(vector_string_T self) -> bool"""
+        return _libBornAgainResample.vector_string_T___nonzero__(self)
 
     def __bool__(self):
-        r"""__bool__(vector_string_t self) -> bool"""
-        return _libBornAgainResample.vector_string_t___bool__(self)
+        r"""__bool__(vector_string_T self) -> bool"""
+        return _libBornAgainResample.vector_string_T___bool__(self)
 
     def __len__(self):
-        r"""__len__(vector_string_t self) -> std::vector< std::string >::size_type"""
-        return _libBornAgainResample.vector_string_t___len__(self)
+        r"""__len__(vector_string_T self) -> std::vector< std::string >::size_type"""
+        return _libBornAgainResample.vector_string_T___len__(self)
 
     def __getslice__(self, i, j):
-        r"""__getslice__(vector_string_t self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j) -> vector_string_t"""
-        return _libBornAgainResample.vector_string_t___getslice__(self, i, j)
+        r"""__getslice__(vector_string_T self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j) -> vector_string_T"""
+        return _libBornAgainResample.vector_string_T___getslice__(self, i, j)
 
     def __setslice__(self, *args):
         r"""
-        __setslice__(vector_string_t self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j)
-        __setslice__(vector_string_t self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j, vector_string_t v)
+        __setslice__(vector_string_T self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j)
+        __setslice__(vector_string_T self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j, vector_string_T v)
         """
-        return _libBornAgainResample.vector_string_t___setslice__(self, *args)
+        return _libBornAgainResample.vector_string_T___setslice__(self, *args)
 
     def __delslice__(self, i, j):
-        r"""__delslice__(vector_string_t self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j)"""
-        return _libBornAgainResample.vector_string_t___delslice__(self, i, j)
+        r"""__delslice__(vector_string_T self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j)"""
+        return _libBornAgainResample.vector_string_T___delslice__(self, i, j)
 
     def __delitem__(self, *args):
         r"""
-        __delitem__(vector_string_t self, std::vector< std::string >::difference_type i)
-        __delitem__(vector_string_t self, SWIGPY_SLICEOBJECT * slice)
+        __delitem__(vector_string_T self, std::vector< std::string >::difference_type i)
+        __delitem__(vector_string_T self, SWIGPY_SLICEOBJECT * slice)
         """
-        return _libBornAgainResample.vector_string_t___delitem__(self, *args)
+        return _libBornAgainResample.vector_string_T___delitem__(self, *args)
 
     def __getitem__(self, *args):
         r"""
-        __getitem__(vector_string_t self, SWIGPY_SLICEOBJECT * slice) -> vector_string_t
-        __getitem__(vector_string_t self, std::vector< std::string >::difference_type i) -> std::vector< std::string >::value_type const &
+        __getitem__(vector_string_T self, SWIGPY_SLICEOBJECT * slice) -> vector_string_T
+        __getitem__(vector_string_T self, std::vector< std::string >::difference_type i) -> std::vector< std::string >::value_type const &
         """
-        return _libBornAgainResample.vector_string_t___getitem__(self, *args)
+        return _libBornAgainResample.vector_string_T___getitem__(self, *args)
 
     def __setitem__(self, *args):
         r"""
-        __setitem__(vector_string_t self, SWIGPY_SLICEOBJECT * slice, vector_string_t v)
-        __setitem__(vector_string_t self, SWIGPY_SLICEOBJECT * slice)
-        __setitem__(vector_string_t self, std::vector< std::string >::difference_type i, std::vector< std::string >::value_type const & x)
+        __setitem__(vector_string_T self, SWIGPY_SLICEOBJECT * slice, vector_string_T v)
+        __setitem__(vector_string_T self, SWIGPY_SLICEOBJECT * slice)
+        __setitem__(vector_string_T self, std::vector< std::string >::difference_type i, std::vector< std::string >::value_type const & x)
         """
-        return _libBornAgainResample.vector_string_t___setitem__(self, *args)
+        return _libBornAgainResample.vector_string_T___setitem__(self, *args)
 
     def pop(self):
-        r"""pop(vector_string_t self) -> std::vector< std::string >::value_type"""
-        return _libBornAgainResample.vector_string_t_pop(self)
+        r"""pop(vector_string_T self) -> std::vector< std::string >::value_type"""
+        return _libBornAgainResample.vector_string_T_pop(self)
 
     def append(self, x):
-        r"""append(vector_string_t self, std::vector< std::string >::value_type const & x)"""
-        return _libBornAgainResample.vector_string_t_append(self, x)
+        r"""append(vector_string_T self, std::vector< std::string >::value_type const & x)"""
+        return _libBornAgainResample.vector_string_T_append(self, x)
 
     def empty(self):
-        r"""empty(vector_string_t self) -> bool"""
-        return _libBornAgainResample.vector_string_t_empty(self)
+        r"""empty(vector_string_T self) -> bool"""
+        return _libBornAgainResample.vector_string_T_empty(self)
 
     def size(self):
-        r"""size(vector_string_t self) -> std::vector< std::string >::size_type"""
-        return _libBornAgainResample.vector_string_t_size(self)
+        r"""size(vector_string_T self) -> std::vector< std::string >::size_type"""
+        return _libBornAgainResample.vector_string_T_size(self)
 
     def swap(self, v):
-        r"""swap(vector_string_t self, vector_string_t v)"""
-        return _libBornAgainResample.vector_string_t_swap(self, v)
+        r"""swap(vector_string_T self, vector_string_T v)"""
+        return _libBornAgainResample.vector_string_T_swap(self, v)
 
     def begin(self):
-        r"""begin(vector_string_t self) -> std::vector< std::string >::iterator"""
-        return _libBornAgainResample.vector_string_t_begin(self)
+        r"""begin(vector_string_T self) -> std::vector< std::string >::iterator"""
+        return _libBornAgainResample.vector_string_T_begin(self)
 
     def end(self):
-        r"""end(vector_string_t self) -> std::vector< std::string >::iterator"""
-        return _libBornAgainResample.vector_string_t_end(self)
+        r"""end(vector_string_T self) -> std::vector< std::string >::iterator"""
+        return _libBornAgainResample.vector_string_T_end(self)
 
     def rbegin(self):
-        r"""rbegin(vector_string_t self) -> std::vector< std::string >::reverse_iterator"""
-        return _libBornAgainResample.vector_string_t_rbegin(self)
+        r"""rbegin(vector_string_T self) -> std::vector< std::string >::reverse_iterator"""
+        return _libBornAgainResample.vector_string_T_rbegin(self)
 
     def rend(self):
-        r"""rend(vector_string_t self) -> std::vector< std::string >::reverse_iterator"""
-        return _libBornAgainResample.vector_string_t_rend(self)
+        r"""rend(vector_string_T self) -> std::vector< std::string >::reverse_iterator"""
+        return _libBornAgainResample.vector_string_T_rend(self)
 
     def clear(self):
-        r"""clear(vector_string_t self)"""
-        return _libBornAgainResample.vector_string_t_clear(self)
+        r"""clear(vector_string_T self)"""
+        return _libBornAgainResample.vector_string_T_clear(self)
 
     def get_allocator(self):
-        r"""get_allocator(vector_string_t self) -> std::vector< std::string >::allocator_type"""
-        return _libBornAgainResample.vector_string_t_get_allocator(self)
+        r"""get_allocator(vector_string_T self) -> std::vector< std::string >::allocator_type"""
+        return _libBornAgainResample.vector_string_T_get_allocator(self)
 
     def pop_back(self):
-        r"""pop_back(vector_string_t self)"""
-        return _libBornAgainResample.vector_string_t_pop_back(self)
+        r"""pop_back(vector_string_T self)"""
+        return _libBornAgainResample.vector_string_T_pop_back(self)
 
     def erase(self, *args):
         r"""
-        erase(vector_string_t self, std::vector< std::string >::iterator pos) -> std::vector< std::string >::iterator
-        erase(vector_string_t self, std::vector< std::string >::iterator first, std::vector< std::string >::iterator last) -> std::vector< std::string >::iterator
+        erase(vector_string_T self, std::vector< std::string >::iterator pos) -> std::vector< std::string >::iterator
+        erase(vector_string_T self, std::vector< std::string >::iterator first, std::vector< std::string >::iterator last) -> std::vector< std::string >::iterator
         """
-        return _libBornAgainResample.vector_string_t_erase(self, *args)
+        return _libBornAgainResample.vector_string_T_erase(self, *args)
 
     def __init__(self, *args):
         r"""
-        __init__(vector_string_t self) -> vector_string_t
-        __init__(vector_string_t self, vector_string_t other) -> vector_string_t
-        __init__(vector_string_t self, std::vector< std::string >::size_type size) -> vector_string_t
-        __init__(vector_string_t self, std::vector< std::string >::size_type size, std::vector< std::string >::value_type const & value) -> vector_string_t
+        __init__(vector_string_T self) -> vector_string_T
+        __init__(vector_string_T self, vector_string_T other) -> vector_string_T
+        __init__(vector_string_T self, std::vector< std::string >::size_type size) -> vector_string_T
+        __init__(vector_string_T self, std::vector< std::string >::size_type size, std::vector< std::string >::value_type const & value) -> vector_string_T
         """
-        _libBornAgainResample.vector_string_t_swiginit(self, _libBornAgainResample.new_vector_string_t(*args))
+        _libBornAgainResample.vector_string_T_swiginit(self, _libBornAgainResample.new_vector_string_T(*args))
 
     def push_back(self, x):
-        r"""push_back(vector_string_t self, std::vector< std::string >::value_type const & x)"""
-        return _libBornAgainResample.vector_string_t_push_back(self, x)
+        r"""push_back(vector_string_T self, std::vector< std::string >::value_type const & x)"""
+        return _libBornAgainResample.vector_string_T_push_back(self, x)
 
     def front(self):
-        r"""front(vector_string_t self) -> std::vector< std::string >::value_type const &"""
-        return _libBornAgainResample.vector_string_t_front(self)
+        r"""front(vector_string_T self) -> std::vector< std::string >::value_type const &"""
+        return _libBornAgainResample.vector_string_T_front(self)
 
     def back(self):
-        r"""back(vector_string_t self) -> std::vector< std::string >::value_type const &"""
-        return _libBornAgainResample.vector_string_t_back(self)
+        r"""back(vector_string_T self) -> std::vector< std::string >::value_type const &"""
+        return _libBornAgainResample.vector_string_T_back(self)
 
     def assign(self, n, x):
-        r"""assign(vector_string_t self, std::vector< std::string >::size_type n, std::vector< std::string >::value_type const & x)"""
-        return _libBornAgainResample.vector_string_t_assign(self, n, x)
+        r"""assign(vector_string_T self, std::vector< std::string >::size_type n, std::vector< std::string >::value_type const & x)"""
+        return _libBornAgainResample.vector_string_T_assign(self, n, x)
 
     def resize(self, *args):
         r"""
-        resize(vector_string_t self, std::vector< std::string >::size_type new_size)
-        resize(vector_string_t self, std::vector< std::string >::size_type new_size, std::vector< std::string >::value_type const & x)
+        resize(vector_string_T self, std::vector< std::string >::size_type new_size)
+        resize(vector_string_T self, std::vector< std::string >::size_type new_size, std::vector< std::string >::value_type const & x)
         """
-        return _libBornAgainResample.vector_string_t_resize(self, *args)
+        return _libBornAgainResample.vector_string_T_resize(self, *args)
 
     def insert(self, *args):
         r"""
-        insert(vector_string_t self, std::vector< std::string >::iterator pos, std::vector< std::string >::value_type const & x) -> std::vector< std::string >::iterator
-        insert(vector_string_t self, std::vector< std::string >::iterator pos, std::vector< std::string >::size_type n, std::vector< std::string >::value_type const & x)
+        insert(vector_string_T self, std::vector< std::string >::iterator pos, std::vector< std::string >::value_type const & x) -> std::vector< std::string >::iterator
+        insert(vector_string_T self, std::vector< std::string >::iterator pos, std::vector< std::string >::size_type n, std::vector< std::string >::value_type const & x)
         """
-        return _libBornAgainResample.vector_string_t_insert(self, *args)
+        return _libBornAgainResample.vector_string_T_insert(self, *args)
 
     def reserve(self, n):
-        r"""reserve(vector_string_t self, std::vector< std::string >::size_type n)"""
-        return _libBornAgainResample.vector_string_t_reserve(self, n)
+        r"""reserve(vector_string_T self, std::vector< std::string >::size_type n)"""
+        return _libBornAgainResample.vector_string_T_reserve(self, n)
 
     def capacity(self):
-        r"""capacity(vector_string_t self) -> std::vector< std::string >::size_type"""
-        return _libBornAgainResample.vector_string_t_capacity(self)
-    __swig_destroy__ = _libBornAgainResample.delete_vector_string_t
+        r"""capacity(vector_string_T self) -> std::vector< std::string >::size_type"""
+        return _libBornAgainResample.vector_string_T_capacity(self)
+    __swig_destroy__ = _libBornAgainResample.delete_vector_string_T
 
-# Register vector_string_t in _libBornAgainResample:
-_libBornAgainResample.vector_string_t_swigregister(vector_string_t)
-class map_string_double_t(object):
+# Register vector_string_T in _libBornAgainResample:
+_libBornAgainResample.vector_string_T_swigregister(vector_string_T)
+class map_string_double_T(object):
     r"""Proxy of C++ std::map< std::string,double > class."""
 
     thisown = property(lambda x: x.this.own(), lambda x, v: x.this.own(v), doc="The membership flag")
     __repr__ = _swig_repr
 
     def iterator(self):
-        r"""iterator(map_string_double_t self) -> SwigPyIterator"""
-        return _libBornAgainResample.map_string_double_t_iterator(self)
+        r"""iterator(map_string_double_T self) -> SwigPyIterator"""
+        return _libBornAgainResample.map_string_double_T_iterator(self)
     def __iter__(self):
         return self.iterator()
 
     def __nonzero__(self):
-        r"""__nonzero__(map_string_double_t self) -> bool"""
-        return _libBornAgainResample.map_string_double_t___nonzero__(self)
+        r"""__nonzero__(map_string_double_T self) -> bool"""
+        return _libBornAgainResample.map_string_double_T___nonzero__(self)
 
     def __bool__(self):
-        r"""__bool__(map_string_double_t self) -> bool"""
-        return _libBornAgainResample.map_string_double_t___bool__(self)
+        r"""__bool__(map_string_double_T self) -> bool"""
+        return _libBornAgainResample.map_string_double_T___bool__(self)
 
     def __len__(self):
-        r"""__len__(map_string_double_t self) -> std::map< std::string,double >::size_type"""
-        return _libBornAgainResample.map_string_double_t___len__(self)
+        r"""__len__(map_string_double_T self) -> std::map< std::string,double >::size_type"""
+        return _libBornAgainResample.map_string_double_T___len__(self)
     def __iter__(self):
         return self.key_iterator()
     def iterkeys(self):
@@ -1348,124 +1348,124 @@ class map_string_double_t(object):
         return self.iterator()
 
     def __getitem__(self, key):
-        r"""__getitem__(map_string_double_t self, std::map< std::string,double >::key_type const & key) -> std::map< std::string,double >::mapped_type const &"""
-        return _libBornAgainResample.map_string_double_t___getitem__(self, key)
+        r"""__getitem__(map_string_double_T self, std::map< std::string,double >::key_type const & key) -> std::map< std::string,double >::mapped_type const &"""
+        return _libBornAgainResample.map_string_double_T___getitem__(self, key)
 
     def __delitem__(self, key):
-        r"""__delitem__(map_string_double_t self, std::map< std::string,double >::key_type const & key)"""
-        return _libBornAgainResample.map_string_double_t___delitem__(self, key)
+        r"""__delitem__(map_string_double_T self, std::map< std::string,double >::key_type const & key)"""
+        return _libBornAgainResample.map_string_double_T___delitem__(self, key)
 
     def has_key(self, key):
-        r"""has_key(map_string_double_t self, std::map< std::string,double >::key_type const & key) -> bool"""
-        return _libBornAgainResample.map_string_double_t_has_key(self, key)
+        r"""has_key(map_string_double_T self, std::map< std::string,double >::key_type const & key) -> bool"""
+        return _libBornAgainResample.map_string_double_T_has_key(self, key)
 
     def keys(self):
-        r"""keys(map_string_double_t self) -> PyObject *"""
-        return _libBornAgainResample.map_string_double_t_keys(self)
+        r"""keys(map_string_double_T self) -> PyObject *"""
+        return _libBornAgainResample.map_string_double_T_keys(self)
 
     def values(self):
-        r"""values(map_string_double_t self) -> PyObject *"""
-        return _libBornAgainResample.map_string_double_t_values(self)
+        r"""values(map_string_double_T self) -> PyObject *"""
+        return _libBornAgainResample.map_string_double_T_values(self)
 
     def items(self):
-        r"""items(map_string_double_t self) -> PyObject *"""
-        return _libBornAgainResample.map_string_double_t_items(self)
+        r"""items(map_string_double_T self) -> PyObject *"""
+        return _libBornAgainResample.map_string_double_T_items(self)
 
     def __contains__(self, key):
-        r"""__contains__(map_string_double_t self, std::map< std::string,double >::key_type const & key) -> bool"""
-        return _libBornAgainResample.map_string_double_t___contains__(self, key)
+        r"""__contains__(map_string_double_T self, std::map< std::string,double >::key_type const & key) -> bool"""
+        return _libBornAgainResample.map_string_double_T___contains__(self, key)
 
     def key_iterator(self):
-        r"""key_iterator(map_string_double_t self) -> SwigPyIterator"""
-        return _libBornAgainResample.map_string_double_t_key_iterator(self)
+        r"""key_iterator(map_string_double_T self) -> SwigPyIterator"""
+        return _libBornAgainResample.map_string_double_T_key_iterator(self)
 
     def value_iterator(self):
-        r"""value_iterator(map_string_double_t self) -> SwigPyIterator"""
-        return _libBornAgainResample.map_string_double_t_value_iterator(self)
+        r"""value_iterator(map_string_double_T self) -> SwigPyIterator"""
+        return _libBornAgainResample.map_string_double_T_value_iterator(self)
 
     def __setitem__(self, *args):
         r"""
-        __setitem__(map_string_double_t self, std::map< std::string,double >::key_type const & key)
-        __setitem__(map_string_double_t self, std::map< std::string,double >::key_type const & key, std::map< std::string,double >::mapped_type const & x)
+        __setitem__(map_string_double_T self, std::map< std::string,double >::key_type const & key)
+        __setitem__(map_string_double_T self, std::map< std::string,double >::key_type const & key, std::map< std::string,double >::mapped_type const & x)
         """
-        return _libBornAgainResample.map_string_double_t___setitem__(self, *args)
+        return _libBornAgainResample.map_string_double_T___setitem__(self, *args)
 
     def asdict(self):
-        r"""asdict(map_string_double_t self) -> PyObject *"""
-        return _libBornAgainResample.map_string_double_t_asdict(self)
+        r"""asdict(map_string_double_T self) -> PyObject *"""
+        return _libBornAgainResample.map_string_double_T_asdict(self)
 
     def __init__(self, *args):
         r"""
-        __init__(map_string_double_t self, std::less< std::string > const & other) -> map_string_double_t
-        __init__(map_string_double_t self) -> map_string_double_t
-        __init__(map_string_double_t self, map_string_double_t other) -> map_string_double_t
+        __init__(map_string_double_T self, std::less< std::string > const & other) -> map_string_double_T
+        __init__(map_string_double_T self) -> map_string_double_T
+        __init__(map_string_double_T self, map_string_double_T other) -> map_string_double_T
         """
-        _libBornAgainResample.map_string_double_t_swiginit(self, _libBornAgainResample.new_map_string_double_t(*args))
+        _libBornAgainResample.map_string_double_T_swiginit(self, _libBornAgainResample.new_map_string_double_T(*args))
 
     def empty(self):
-        r"""empty(map_string_double_t self) -> bool"""
-        return _libBornAgainResample.map_string_double_t_empty(self)
+        r"""empty(map_string_double_T self) -> bool"""
+        return _libBornAgainResample.map_string_double_T_empty(self)
 
     def size(self):
-        r"""size(map_string_double_t self) -> std::map< std::string,double >::size_type"""
-        return _libBornAgainResample.map_string_double_t_size(self)
+        r"""size(map_string_double_T self) -> std::map< std::string,double >::size_type"""
+        return _libBornAgainResample.map_string_double_T_size(self)
 
     def swap(self, v):
-        r"""swap(map_string_double_t self, map_string_double_t v)"""
-        return _libBornAgainResample.map_string_double_t_swap(self, v)
+        r"""swap(map_string_double_T self, map_string_double_T v)"""
+        return _libBornAgainResample.map_string_double_T_swap(self, v)
 
     def begin(self):
-        r"""begin(map_string_double_t self) -> std::map< std::string,double >::iterator"""
-        return _libBornAgainResample.map_string_double_t_begin(self)
+        r"""begin(map_string_double_T self) -> std::map< std::string,double >::iterator"""
+        return _libBornAgainResample.map_string_double_T_begin(self)
 
     def end(self):
-        r"""end(map_string_double_t self) -> std::map< std::string,double >::iterator"""
-        return _libBornAgainResample.map_string_double_t_end(self)
+        r"""end(map_string_double_T self) -> std::map< std::string,double >::iterator"""
+        return _libBornAgainResample.map_string_double_T_end(self)
 
     def rbegin(self):
-        r"""rbegin(map_string_double_t self) -> std::map< std::string,double >::reverse_iterator"""
-        return _libBornAgainResample.map_string_double_t_rbegin(self)
+        r"""rbegin(map_string_double_T self) -> std::map< std::string,double >::reverse_iterator"""
+        return _libBornAgainResample.map_string_double_T_rbegin(self)
 
     def rend(self):
-        r"""rend(map_string_double_t self) -> std::map< std::string,double >::reverse_iterator"""
-        return _libBornAgainResample.map_string_double_t_rend(self)
+        r"""rend(map_string_double_T self) -> std::map< std::string,double >::reverse_iterator"""
+        return _libBornAgainResample.map_string_double_T_rend(self)
 
     def clear(self):
-        r"""clear(map_string_double_t self)"""
-        return _libBornAgainResample.map_string_double_t_clear(self)
+        r"""clear(map_string_double_T self)"""
+        return _libBornAgainResample.map_string_double_T_clear(self)
 
     def get_allocator(self):
-        r"""get_allocator(map_string_double_t self) -> std::map< std::string,double >::allocator_type"""
-        return _libBornAgainResample.map_string_double_t_get_allocator(self)
+        r"""get_allocator(map_string_double_T self) -> std::map< std::string,double >::allocator_type"""
+        return _libBornAgainResample.map_string_double_T_get_allocator(self)
 
     def count(self, x):
-        r"""count(map_string_double_t self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::size_type"""
-        return _libBornAgainResample.map_string_double_t_count(self, x)
+        r"""count(map_string_double_T self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::size_type"""
+        return _libBornAgainResample.map_string_double_T_count(self, x)
 
     def erase(self, *args):
         r"""
-        erase(map_string_double_t self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::size_type
-        erase(map_string_double_t self, std::map< std::string,double >::iterator position)
-        erase(map_string_double_t self, std::map< std::string,double >::iterator first, std::map< std::string,double >::iterator last)
+        erase(map_string_double_T self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::size_type
+        erase(map_string_double_T self, std::map< std::string,double >::iterator position)
+        erase(map_string_double_T self, std::map< std::string,double >::iterator first, std::map< std::string,double >::iterator last)
         """
-        return _libBornAgainResample.map_string_double_t_erase(self, *args)
+        return _libBornAgainResample.map_string_double_T_erase(self, *args)
 
     def find(self, x):
-        r"""find(map_string_double_t self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"""
-        return _libBornAgainResample.map_string_double_t_find(self, x)
+        r"""find(map_string_double_T self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"""
+        return _libBornAgainResample.map_string_double_T_find(self, x)
 
     def lower_bound(self, x):
-        r"""lower_bound(map_string_double_t self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"""
-        return _libBornAgainResample.map_string_double_t_lower_bound(self, x)
+        r"""lower_bound(map_string_double_T self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"""
+        return _libBornAgainResample.map_string_double_T_lower_bound(self, x)
 
     def upper_bound(self, x):
-        r"""upper_bound(map_string_double_t self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"""
-        return _libBornAgainResample.map_string_double_t_upper_bound(self, x)
-    __swig_destroy__ = _libBornAgainResample.delete_map_string_double_t
+        r"""upper_bound(map_string_double_T self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"""
+        return _libBornAgainResample.map_string_double_T_upper_bound(self, x)
+    __swig_destroy__ = _libBornAgainResample.delete_map_string_double_T
 
-# Register map_string_double_t in _libBornAgainResample:
-_libBornAgainResample.map_string_double_t_swigregister(map_string_double_t)
-class pvacuum_double_t(object):
+# Register map_string_double_T in _libBornAgainResample:
+_libBornAgainResample.map_string_double_T_swigregister(map_string_double_T)
+class pvacuum_double_T(object):
     r"""Proxy of C++ std::pair< double,double > class."""
 
     thisown = property(lambda x: x.this.own(), lambda x, v: x.this.own(v), doc="The membership flag")
@@ -1473,13 +1473,13 @@ class pvacuum_double_t(object):
 
     def __init__(self, *args):
         r"""
-        __init__(pvacuum_double_t self) -> pvacuum_double_t
-        __init__(pvacuum_double_t self, double first, double second) -> pvacuum_double_t
-        __init__(pvacuum_double_t self, pvacuum_double_t other) -> pvacuum_double_t
+        __init__(pvacuum_double_T self) -> pvacuum_double_T
+        __init__(pvacuum_double_T self, double first, double second) -> pvacuum_double_T
+        __init__(pvacuum_double_T self, pvacuum_double_T other) -> pvacuum_double_T
         """
-        _libBornAgainResample.pvacuum_double_t_swiginit(self, _libBornAgainResample.new_pvacuum_double_t(*args))
-    first = property(_libBornAgainResample.pvacuum_double_t_first_get, _libBornAgainResample.pvacuum_double_t_first_set, doc=r"""first : double""")
-    second = property(_libBornAgainResample.pvacuum_double_t_second_get, _libBornAgainResample.pvacuum_double_t_second_set, doc=r"""second : double""")
+        _libBornAgainResample.pvacuum_double_T_swiginit(self, _libBornAgainResample.new_pvacuum_double_T(*args))
+    first = property(_libBornAgainResample.pvacuum_double_T_first_get, _libBornAgainResample.pvacuum_double_T_first_set, doc=r"""first : double""")
+    second = property(_libBornAgainResample.pvacuum_double_T_second_get, _libBornAgainResample.pvacuum_double_T_second_set, doc=r"""second : double""")
     def __len__(self):
         return 2
     def __repr__(self):
@@ -1494,176 +1494,176 @@ class pvacuum_double_t(object):
             self.first = val
         else:
             self.second = val
-    __swig_destroy__ = _libBornAgainResample.delete_pvacuum_double_t
+    __swig_destroy__ = _libBornAgainResample.delete_pvacuum_double_T
 
-# Register pvacuum_double_t in _libBornAgainResample:
-_libBornAgainResample.pvacuum_double_t_swigregister(pvacuum_double_t)
-class vector_pvacuum_double_t(object):
+# Register pvacuum_double_T in _libBornAgainResample:
+_libBornAgainResample.pvacuum_double_T_swigregister(pvacuum_double_T)
+class vector_pvacuum_double_T(object):
     r"""Proxy of C++ std::vector< std::pair< double,double > > class."""
 
     thisown = property(lambda x: x.this.own(), lambda x, v: x.this.own(v), doc="The membership flag")
     __repr__ = _swig_repr
 
     def iterator(self):
-        r"""iterator(vector_pvacuum_double_t self) -> SwigPyIterator"""
-        return _libBornAgainResample.vector_pvacuum_double_t_iterator(self)
+        r"""iterator(vector_pvacuum_double_T self) -> SwigPyIterator"""
+        return _libBornAgainResample.vector_pvacuum_double_T_iterator(self)
     def __iter__(self):
         return self.iterator()
 
     def __nonzero__(self):
-        r"""__nonzero__(vector_pvacuum_double_t self) -> bool"""
-        return _libBornAgainResample.vector_pvacuum_double_t___nonzero__(self)
+        r"""__nonzero__(vector_pvacuum_double_T self) -> bool"""
+        return _libBornAgainResample.vector_pvacuum_double_T___nonzero__(self)
 
     def __bool__(self):
-        r"""__bool__(vector_pvacuum_double_t self) -> bool"""
-        return _libBornAgainResample.vector_pvacuum_double_t___bool__(self)
+        r"""__bool__(vector_pvacuum_double_T self) -> bool"""
+        return _libBornAgainResample.vector_pvacuum_double_T___bool__(self)
 
     def __len__(self):
-        r"""__len__(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::size_type"""
-        return _libBornAgainResample.vector_pvacuum_double_t___len__(self)
+        r"""__len__(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::size_type"""
+        return _libBornAgainResample.vector_pvacuum_double_T___len__(self)
 
     def __getslice__(self, i, j):
-        r"""__getslice__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j) -> vector_pvacuum_double_t"""
-        return _libBornAgainResample.vector_pvacuum_double_t___getslice__(self, i, j)
+        r"""__getslice__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j) -> vector_pvacuum_double_T"""
+        return _libBornAgainResample.vector_pvacuum_double_T___getslice__(self, i, j)
 
     def __setslice__(self, *args):
         r"""
-        __setslice__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j)
-        __setslice__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j, vector_pvacuum_double_t v)
+        __setslice__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j)
+        __setslice__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j, vector_pvacuum_double_T v)
         """
-        return _libBornAgainResample.vector_pvacuum_double_t___setslice__(self, *args)
+        return _libBornAgainResample.vector_pvacuum_double_T___setslice__(self, *args)
 
     def __delslice__(self, i, j):
-        r"""__delslice__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j)"""
-        return _libBornAgainResample.vector_pvacuum_double_t___delslice__(self, i, j)
+        r"""__delslice__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j)"""
+        return _libBornAgainResample.vector_pvacuum_double_T___delslice__(self, i, j)
 
     def __delitem__(self, *args):
         r"""
-        __delitem__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i)
-        __delitem__(vector_pvacuum_double_t self, SWIGPY_SLICEOBJECT * slice)
+        __delitem__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i)
+        __delitem__(vector_pvacuum_double_T self, SWIGPY_SLICEOBJECT * slice)
         """
-        return _libBornAgainResample.vector_pvacuum_double_t___delitem__(self, *args)
+        return _libBornAgainResample.vector_pvacuum_double_T___delitem__(self, *args)
 
     def __getitem__(self, *args):
         r"""
-        __getitem__(vector_pvacuum_double_t self, SWIGPY_SLICEOBJECT * slice) -> vector_pvacuum_double_t
-        __getitem__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i) -> pvacuum_double_t
+        __getitem__(vector_pvacuum_double_T self, SWIGPY_SLICEOBJECT * slice) -> vector_pvacuum_double_T
+        __getitem__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i) -> pvacuum_double_T
         """
-        return _libBornAgainResample.vector_pvacuum_double_t___getitem__(self, *args)
+        return _libBornAgainResample.vector_pvacuum_double_T___getitem__(self, *args)
 
     def __setitem__(self, *args):
         r"""
-        __setitem__(vector_pvacuum_double_t self, SWIGPY_SLICEOBJECT * slice, vector_pvacuum_double_t v)
-        __setitem__(vector_pvacuum_double_t self, SWIGPY_SLICEOBJECT * slice)
-        __setitem__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i, pvacuum_double_t x)
+        __setitem__(vector_pvacuum_double_T self, SWIGPY_SLICEOBJECT * slice, vector_pvacuum_double_T v)
+        __setitem__(vector_pvacuum_double_T self, SWIGPY_SLICEOBJECT * slice)
+        __setitem__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i, pvacuum_double_T x)
         """
-        return _libBornAgainResample.vector_pvacuum_double_t___setitem__(self, *args)
+        return _libBornAgainResample.vector_pvacuum_double_T___setitem__(self, *args)
 
     def pop(self):
-        r"""pop(vector_pvacuum_double_t self) -> pvacuum_double_t"""
-        return _libBornAgainResample.vector_pvacuum_double_t_pop(self)
+        r"""pop(vector_pvacuum_double_T self) -> pvacuum_double_T"""
+        return _libBornAgainResample.vector_pvacuum_double_T_pop(self)
 
     def append(self, x):
-        r"""append(vector_pvacuum_double_t self, pvacuum_double_t x)"""
-        return _libBornAgainResample.vector_pvacuum_double_t_append(self, x)
+        r"""append(vector_pvacuum_double_T self, pvacuum_double_T x)"""
+        return _libBornAgainResample.vector_pvacuum_double_T_append(self, x)
 
     def empty(self):
-        r"""empty(vector_pvacuum_double_t self) -> bool"""
-        return _libBornAgainResample.vector_pvacuum_double_t_empty(self)
+        r"""empty(vector_pvacuum_double_T self) -> bool"""
+        return _libBornAgainResample.vector_pvacuum_double_T_empty(self)
 
     def size(self):
-        r"""size(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::size_type"""
-        return _libBornAgainResample.vector_pvacuum_double_t_size(self)
+        r"""size(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::size_type"""
+        return _libBornAgainResample.vector_pvacuum_double_T_size(self)
 
     def swap(self, v):
-        r"""swap(vector_pvacuum_double_t self, vector_pvacuum_double_t v)"""
-        return _libBornAgainResample.vector_pvacuum_double_t_swap(self, v)
+        r"""swap(vector_pvacuum_double_T self, vector_pvacuum_double_T v)"""
+        return _libBornAgainResample.vector_pvacuum_double_T_swap(self, v)
 
     def begin(self):
-        r"""begin(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::iterator"""
-        return _libBornAgainResample.vector_pvacuum_double_t_begin(self)
+        r"""begin(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::iterator"""
+        return _libBornAgainResample.vector_pvacuum_double_T_begin(self)
 
     def end(self):
-        r"""end(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::iterator"""
-        return _libBornAgainResample.vector_pvacuum_double_t_end(self)
+        r"""end(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::iterator"""
+        return _libBornAgainResample.vector_pvacuum_double_T_end(self)
 
     def rbegin(self):
-        r"""rbegin(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::reverse_iterator"""
-        return _libBornAgainResample.vector_pvacuum_double_t_rbegin(self)
+        r"""rbegin(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::reverse_iterator"""
+        return _libBornAgainResample.vector_pvacuum_double_T_rbegin(self)
 
     def rend(self):
-        r"""rend(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::reverse_iterator"""
-        return _libBornAgainResample.vector_pvacuum_double_t_rend(self)
+        r"""rend(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::reverse_iterator"""
+        return _libBornAgainResample.vector_pvacuum_double_T_rend(self)
 
     def clear(self):
-        r"""clear(vector_pvacuum_double_t self)"""
-        return _libBornAgainResample.vector_pvacuum_double_t_clear(self)
+        r"""clear(vector_pvacuum_double_T self)"""
+        return _libBornAgainResample.vector_pvacuum_double_T_clear(self)
 
     def get_allocator(self):
-        r"""get_allocator(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::allocator_type"""
-        return _libBornAgainResample.vector_pvacuum_double_t_get_allocator(self)
+        r"""get_allocator(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::allocator_type"""
+        return _libBornAgainResample.vector_pvacuum_double_T_get_allocator(self)
 
     def pop_back(self):
-        r"""pop_back(vector_pvacuum_double_t self)"""
-        return _libBornAgainResample.vector_pvacuum_double_t_pop_back(self)
+        r"""pop_back(vector_pvacuum_double_T self)"""
+        return _libBornAgainResample.vector_pvacuum_double_T_pop_back(self)
 
     def erase(self, *args):
         r"""
-        erase(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::iterator pos) -> std::vector< std::pair< double,double > >::iterator
-        erase(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::iterator first, std::vector< std::pair< double,double > >::iterator last) -> std::vector< std::pair< double,double > >::iterator
+        erase(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::iterator pos) -> std::vector< std::pair< double,double > >::iterator
+        erase(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::iterator first, std::vector< std::pair< double,double > >::iterator last) -> std::vector< std::pair< double,double > >::iterator
         """
-        return _libBornAgainResample.vector_pvacuum_double_t_erase(self, *args)
+        return _libBornAgainResample.vector_pvacuum_double_T_erase(self, *args)
 
     def __init__(self, *args):
         r"""
-        __init__(vector_pvacuum_double_t self) -> vector_pvacuum_double_t
-        __init__(vector_pvacuum_double_t self, vector_pvacuum_double_t other) -> vector_pvacuum_double_t
-        __init__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::size_type size) -> vector_pvacuum_double_t
-        __init__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::size_type size, pvacuum_double_t value) -> vector_pvacuum_double_t
+        __init__(vector_pvacuum_double_T self) -> vector_pvacuum_double_T
+        __init__(vector_pvacuum_double_T self, vector_pvacuum_double_T other) -> vector_pvacuum_double_T
+        __init__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::size_type size) -> vector_pvacuum_double_T
+        __init__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::size_type size, pvacuum_double_T value) -> vector_pvacuum_double_T
         """
-        _libBornAgainResample.vector_pvacuum_double_t_swiginit(self, _libBornAgainResample.new_vector_pvacuum_double_t(*args))
+        _libBornAgainResample.vector_pvacuum_double_T_swiginit(self, _libBornAgainResample.new_vector_pvacuum_double_T(*args))
 
     def push_back(self, x):
-        r"""push_back(vector_pvacuum_double_t self, pvacuum_double_t x)"""
-        return _libBornAgainResample.vector_pvacuum_double_t_push_back(self, x)
+        r"""push_back(vector_pvacuum_double_T self, pvacuum_double_T x)"""
+        return _libBornAgainResample.vector_pvacuum_double_T_push_back(self, x)
 
     def front(self):
-        r"""front(vector_pvacuum_double_t self) -> pvacuum_double_t"""
-        return _libBornAgainResample.vector_pvacuum_double_t_front(self)
+        r"""front(vector_pvacuum_double_T self) -> pvacuum_double_T"""
+        return _libBornAgainResample.vector_pvacuum_double_T_front(self)
 
     def back(self):
-        r"""back(vector_pvacuum_double_t self) -> pvacuum_double_t"""
-        return _libBornAgainResample.vector_pvacuum_double_t_back(self)
+        r"""back(vector_pvacuum_double_T self) -> pvacuum_double_T"""
+        return _libBornAgainResample.vector_pvacuum_double_T_back(self)
 
     def assign(self, n, x):
-        r"""assign(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::size_type n, pvacuum_double_t x)"""
-        return _libBornAgainResample.vector_pvacuum_double_t_assign(self, n, x)
+        r"""assign(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::size_type n, pvacuum_double_T x)"""
+        return _libBornAgainResample.vector_pvacuum_double_T_assign(self, n, x)
 
     def resize(self, *args):
         r"""
-        resize(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::size_type new_size)
-        resize(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::size_type new_size, pvacuum_double_t x)
+        resize(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::size_type new_size)
+        resize(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::size_type new_size, pvacuum_double_T x)
         """
-        return _libBornAgainResample.vector_pvacuum_double_t_resize(self, *args)
+        return _libBornAgainResample.vector_pvacuum_double_T_resize(self, *args)
 
     def insert(self, *args):
         r"""
-        insert(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::iterator pos, pvacuum_double_t x) -> std::vector< std::pair< double,double > >::iterator
-        insert(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::iterator pos, std::vector< std::pair< double,double > >::size_type n, pvacuum_double_t x)
+        insert(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::iterator pos, pvacuum_double_T x) -> std::vector< std::pair< double,double > >::iterator
+        insert(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::iterator pos, std::vector< std::pair< double,double > >::size_type n, pvacuum_double_T x)
         """
-        return _libBornAgainResample.vector_pvacuum_double_t_insert(self, *args)
+        return _libBornAgainResample.vector_pvacuum_double_T_insert(self, *args)
 
     def reserve(self, n):
-        r"""reserve(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::size_type n)"""
-        return _libBornAgainResample.vector_pvacuum_double_t_reserve(self, n)
+        r"""reserve(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::size_type n)"""
+        return _libBornAgainResample.vector_pvacuum_double_T_reserve(self, n)
 
     def capacity(self):
-        r"""capacity(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::size_type"""
-        return _libBornAgainResample.vector_pvacuum_double_t_capacity(self)
-    __swig_destroy__ = _libBornAgainResample.delete_vector_pvacuum_double_t
+        r"""capacity(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::size_type"""
+        return _libBornAgainResample.vector_pvacuum_double_T_capacity(self)
+    __swig_destroy__ = _libBornAgainResample.delete_vector_pvacuum_double_T
 
-# Register vector_pvacuum_double_t in _libBornAgainResample:
-_libBornAgainResample.vector_pvacuum_double_t_swigregister(vector_pvacuum_double_t)
+# Register vector_pvacuum_double_T in _libBornAgainResample:
+_libBornAgainResample.vector_pvacuum_double_T_swigregister(vector_pvacuum_double_T)
 class MesoOptions(object):
     r"""Proxy of C++ MesoOptions class."""
 
@@ -2085,17 +2085,17 @@ class vector_R3(object):
 _libBornAgainResample.vector_R3_swigregister(vector_R3)
 
 def generateZValues(n_points, z_min, z_max):
-    r"""generateZValues(int n_points, double z_min, double z_max) -> vdouble1d_t"""
+    r"""generateZValues(int n_points, double z_min, double z_max) -> vdouble1d_T"""
     return _libBornAgainResample.generateZValues(n_points, z_min, z_max)
 
 def materialProfileSLD(sample, n_points, z_min, z_max):
-    r"""materialProfileSLD(MultiLayer const & sample, int n_points, double z_min, double z_max) -> vector_complex_t"""
+    r"""materialProfileSLD(MultiLayer const & sample, int n_points, double z_min, double z_max) -> vector_complex_T"""
     return _libBornAgainResample.materialProfileSLD(sample, n_points, z_min, z_max)
 
 def magnetizationProfile(sample, xyz, n_points, z_min, z_max):
-    r"""magnetizationProfile(MultiLayer const & sample, std::string xyz, int n_points, double z_min, double z_max) -> vdouble1d_t"""
+    r"""magnetizationProfile(MultiLayer const & sample, std::string xyz, int n_points, double z_min, double z_max) -> vdouble1d_T"""
     return _libBornAgainResample.magnetizationProfile(sample, xyz, n_points, z_min, z_max)
 
 def defaultMaterialProfileLimits(sample):
-    r"""defaultMaterialProfileLimits(MultiLayer const & sample) -> pvacuum_double_t"""
+    r"""defaultMaterialProfileLimits(MultiLayer const & sample) -> pvacuum_double_T"""
     return _libBornAgainResample.defaultMaterialProfileLimits(sample)
diff --git a/auto/Wrap/libBornAgainResample_wrap.cpp b/auto/Wrap/libBornAgainResample_wrap.cpp
index 9700cd22554fc120ed66e4b077ab964c22420aad..5a60900fc7c41efeaa360a4cd04eda8302b2a4e3 100644
--- a/auto/Wrap/libBornAgainResample_wrap.cpp
+++ b/auto/Wrap/libBornAgainResample_wrap.cpp
@@ -7995,7 +7995,7 @@ SWIGINTERN PyObject *SwigPyIterator_swigregister(PyObject *SWIGUNUSEDPARM(self),
   return SWIG_Py_Void();
 }
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_iterator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_iterator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   PyObject **arg2 = (PyObject **) 0 ;
@@ -8010,7 +8010,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_iterator(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_iterator" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_iterator" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = (swig::SwigPyIterator *)std_vector_Sl_double_Sg__iterator(arg1,arg2);
@@ -8021,7 +8021,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___nonzero__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___nonzero__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -8034,7 +8034,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___nonzero__(PyObject *self, PyObject *arg
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___nonzero__" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___nonzero__" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = (bool)std_vector_Sl_double_Sg____nonzero__((std::vector< double > const *)arg1);
@@ -8045,7 +8045,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___bool__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___bool__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -8058,7 +8058,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___bool__(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___bool__" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___bool__" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = (bool)std_vector_Sl_double_Sg____bool__((std::vector< double > const *)arg1);
@@ -8069,7 +8069,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___len__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___len__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -8082,7 +8082,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___len__(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___len__" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___len__" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = std_vector_Sl_double_Sg____len__((std::vector< double > const *)arg1);
@@ -8093,7 +8093,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___getslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___getslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::difference_type arg2 ;
@@ -8108,20 +8108,20 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___getslice__(PyObject *self, PyObject *ar
   std::vector< double,std::allocator< double > > *result = 0 ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_t___getslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_T___getslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___getslice__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___getslice__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t___getslice__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T___getslice__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< double >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_t___getslice__" "', argument " "3"" of type '" "std::vector< double >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_T___getslice__" "', argument " "3"" of type '" "std::vector< double >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< double >::difference_type >(val3);
   try {
@@ -8138,7 +8138,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::difference_type arg2 ;
@@ -8154,17 +8154,17 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setslice____SWIG_0(PyObject *self, Py_s
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___setslice__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___setslice__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t___setslice__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T___setslice__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< double >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_t___setslice__" "', argument " "3"" of type '" "std::vector< double >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_T___setslice__" "', argument " "3"" of type '" "std::vector< double >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< double >::difference_type >(val3);
   try {
@@ -8181,7 +8181,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::difference_type arg2 ;
@@ -8199,27 +8199,27 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setslice____SWIG_1(PyObject *self, Py_s
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___setslice__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___setslice__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t___setslice__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T___setslice__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< double >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_t___setslice__" "', argument " "3"" of type '" "std::vector< double >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_T___setslice__" "', argument " "3"" of type '" "std::vector< double >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< double >::difference_type >(val3);
   {
     std::vector< double,std::allocator< double > > *ptr = (std::vector< double,std::allocator< double > > *)0;
     res4 = swig::asptr(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vdouble1d_t___setslice__" "', argument " "4"" of type '" "std::vector< double,std::allocator< double > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vdouble1d_T___setslice__" "', argument " "4"" of type '" "std::vector< double,std::allocator< double > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble1d_t___setslice__" "', argument " "4"" of type '" "std::vector< double,std::allocator< double > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble1d_T___setslice__" "', argument " "4"" of type '" "std::vector< double,std::allocator< double > > const &""'"); 
     }
     arg4 = ptr;
   }
@@ -8239,13 +8239,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___setslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___setslice__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_t___setslice__", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_T___setslice__", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -8262,7 +8262,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setslice__(PyObject *self, PyObject *ar
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vdouble1d_t___setslice____SWIG_0(self, argc, argv);
+          return _wrap_vdouble1d_T___setslice____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -8285,7 +8285,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setslice__(PyObject *self, PyObject *ar
           int res = swig::asptr(argv[3], (std::vector< double,std::allocator< double > >**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vdouble1d_t___setslice____SWIG_1(self, argc, argv);
+            return _wrap_vdouble1d_T___setslice____SWIG_1(self, argc, argv);
           }
         }
       }
@@ -8293,7 +8293,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setslice__(PyObject *self, PyObject *ar
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_t___setslice__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_T___setslice__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< double >::__setslice__(std::vector< double >::difference_type,std::vector< double >::difference_type)\n"
     "    std::vector< double >::__setslice__(std::vector< double >::difference_type,std::vector< double >::difference_type,std::vector< double,std::allocator< double > > const &)\n");
@@ -8301,7 +8301,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___delslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___delslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::difference_type arg2 ;
@@ -8315,20 +8315,20 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___delslice__(PyObject *self, PyObject *ar
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_t___delslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_T___delslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___delslice__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___delslice__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t___delslice__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T___delslice__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< double >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_t___delslice__" "', argument " "3"" of type '" "std::vector< double >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_T___delslice__" "', argument " "3"" of type '" "std::vector< double >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< double >::difference_type >(val3);
   try {
@@ -8345,7 +8345,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::difference_type arg2 ;
@@ -8358,12 +8358,12 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___delitem____SWIG_0(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___delitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___delitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t___delitem__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T___delitem__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< double >::difference_type >(val2);
   try {
@@ -8380,7 +8380,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -8392,12 +8392,12 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___getitem____SWIG_0(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___getitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___getitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -8415,7 +8415,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -8428,12 +8428,12 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setitem____SWIG_0(PyObject *self, Py_ss
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___setitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___setitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -8441,10 +8441,10 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setitem____SWIG_0(PyObject *self, Py_ss
     std::vector< double,std::allocator< double > > *ptr = (std::vector< double,std::allocator< double > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble1d_t___setitem__" "', argument " "3"" of type '" "std::vector< double,std::allocator< double > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble1d_T___setitem__" "', argument " "3"" of type '" "std::vector< double,std::allocator< double > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble1d_t___setitem__" "', argument " "3"" of type '" "std::vector< double,std::allocator< double > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble1d_T___setitem__" "', argument " "3"" of type '" "std::vector< double,std::allocator< double > > const &""'"); 
     }
     arg3 = ptr;
   }
@@ -8464,7 +8464,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -8475,12 +8475,12 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setitem____SWIG_1(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___setitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___setitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -8498,7 +8498,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -8509,12 +8509,12 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___delitem____SWIG_1(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___delitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___delitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -8532,13 +8532,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___delitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___delitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_t___delitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_T___delitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -8549,7 +8549,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___delitem__(PyObject *self, PyObject *arg
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vdouble1d_t___delitem____SWIG_1(self, argc, argv);
+        return _wrap_vdouble1d_T___delitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -8563,13 +8563,13 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___delitem__(PyObject *self, PyObject *arg
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vdouble1d_t___delitem____SWIG_0(self, argc, argv);
+        return _wrap_vdouble1d_T___delitem____SWIG_0(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_t___delitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_T___delitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< double >::__delitem__(std::vector< double >::difference_type)\n"
     "    std::vector< double >::__delitem__(SWIGPY_SLICEOBJECT *)\n");
@@ -8577,7 +8577,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::difference_type arg2 ;
@@ -8591,12 +8591,12 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___getitem____SWIG_1(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___getitem__" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___getitem__" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t___getitem__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T___getitem__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< double >::difference_type >(val2);
   try {
@@ -8612,13 +8612,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___getitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___getitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_t___getitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_T___getitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -8629,7 +8629,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___getitem__(PyObject *self, PyObject *arg
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vdouble1d_t___getitem____SWIG_0(self, argc, argv);
+        return _wrap_vdouble1d_T___getitem____SWIG_0(self, argc, argv);
       }
     }
   }
@@ -8643,13 +8643,13 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___getitem__(PyObject *self, PyObject *arg
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vdouble1d_t___getitem____SWIG_1(self, argc, argv);
+        return _wrap_vdouble1d_T___getitem____SWIG_1(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_t___getitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_T___getitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< double >::__getitem__(SWIGPY_SLICEOBJECT *)\n"
     "    std::vector< double >::__getitem__(std::vector< double >::difference_type) const\n");
@@ -8657,7 +8657,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::difference_type arg2 ;
@@ -8674,17 +8674,17 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setitem____SWIG_2(PyObject *self, Py_ss
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___setitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___setitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t___setitem__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T___setitem__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< double >::difference_type >(val2);
   ecode3 = SWIG_AsVal_double(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_t___setitem__" "', argument " "3"" of type '" "std::vector< double >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_T___setitem__" "', argument " "3"" of type '" "std::vector< double >::value_type""'");
   } 
   temp3 = static_cast< std::vector< double >::value_type >(val3);
   arg3 = &temp3;
@@ -8700,13 +8700,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___setitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___setitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_t___setitem__", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_T___setitem__", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -8717,7 +8717,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setitem__(PyObject *self, PyObject *arg
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vdouble1d_t___setitem____SWIG_1(self, argc, argv);
+        return _wrap_vdouble1d_T___setitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -8733,7 +8733,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setitem__(PyObject *self, PyObject *arg
         int res = swig::asptr(argv[2], (std::vector< double,std::allocator< double > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vdouble1d_t___setitem____SWIG_0(self, argc, argv);
+          return _wrap_vdouble1d_T___setitem____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -8753,14 +8753,14 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setitem__(PyObject *self, PyObject *arg
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vdouble1d_t___setitem____SWIG_2(self, argc, argv);
+          return _wrap_vdouble1d_T___setitem____SWIG_2(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_t___setitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_T___setitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< double >::__setitem__(SWIGPY_SLICEOBJECT *,std::vector< double,std::allocator< double > > const &)\n"
     "    std::vector< double >::__setitem__(SWIGPY_SLICEOBJECT *)\n"
@@ -8769,7 +8769,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_pop(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_pop(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -8782,7 +8782,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_pop(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_pop" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_pop" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   try {
@@ -8797,7 +8797,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_append(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_append(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::value_type *arg2 = 0 ;
@@ -8809,15 +8809,15 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_append(PyObject *self, PyObject *args) {
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_t_append", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_T_append", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_append" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_append" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_double(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t_append" "', argument " "2"" of type '" "std::vector< double >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T_append" "', argument " "2"" of type '" "std::vector< double >::value_type""'");
   } 
   temp2 = static_cast< std::vector< double >::value_type >(val2);
   arg2 = &temp2;
@@ -8829,7 +8829,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vdouble1d_t__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
+SWIGINTERN PyObject *_wrap_new_vdouble1d_T__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
   PyObject *resultobj = 0;
   std::vector< double > *result = 0 ;
   
@@ -8843,7 +8843,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vdouble1d_t__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vdouble1d_T__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = 0 ;
   int res1 = SWIG_OLDOBJ ;
@@ -8855,10 +8855,10 @@ SWIGINTERN PyObject *_wrap_new_vdouble1d_t__SWIG_1(PyObject *self, Py_ssize_t no
     std::vector< double,std::allocator< double > > *ptr = (std::vector< double,std::allocator< double > > *)0;
     res1 = swig::asptr(swig_obj[0], &ptr);
     if (!SWIG_IsOK(res1)) {
-      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vdouble1d_t" "', argument " "1"" of type '" "std::vector< double > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vdouble1d_T" "', argument " "1"" of type '" "std::vector< double > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vdouble1d_t" "', argument " "1"" of type '" "std::vector< double > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vdouble1d_T" "', argument " "1"" of type '" "std::vector< double > const &""'"); 
     }
     arg1 = ptr;
   }
@@ -8872,7 +8872,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_empty(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_empty(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -8885,7 +8885,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_empty(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_empty" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_empty" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = (bool)((std::vector< double > const *)arg1)->empty();
@@ -8896,7 +8896,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_size(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_size(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -8909,7 +8909,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_size(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_size" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_size" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = ((std::vector< double > const *)arg1)->size();
@@ -8920,7 +8920,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_swap(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_swap(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double > *arg2 = 0 ;
@@ -8931,18 +8931,18 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_swap(PyObject *self, PyObject *args) {
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_t_swap", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_T_swap", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_swap" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_swap" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], &argp2, SWIGTYPE_p_std__vectorT_double_t,  0 );
   if (!SWIG_IsOK(res2)) {
-    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vdouble1d_t_swap" "', argument " "2"" of type '" "std::vector< double > &""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vdouble1d_T_swap" "', argument " "2"" of type '" "std::vector< double > &""'"); 
   }
   if (!argp2) {
-    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble1d_t_swap" "', argument " "2"" of type '" "std::vector< double > &""'"); 
+    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble1d_T_swap" "', argument " "2"" of type '" "std::vector< double > &""'"); 
   }
   arg2 = reinterpret_cast< std::vector< double > * >(argp2);
   (arg1)->swap(*arg2);
@@ -8953,7 +8953,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_begin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_begin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -8966,7 +8966,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_begin(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_begin" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_begin" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = (arg1)->begin();
@@ -8978,7 +8978,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_end(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_end(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -8991,7 +8991,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_end(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_end" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_end" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = (arg1)->end();
@@ -9003,7 +9003,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_rbegin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_rbegin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -9016,7 +9016,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_rbegin(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_rbegin" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_rbegin" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = (arg1)->rbegin();
@@ -9028,7 +9028,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_rend(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_rend(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -9041,7 +9041,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_rend(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_rend" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_rend" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = (arg1)->rend();
@@ -9053,7 +9053,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_clear(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_clear(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -9065,7 +9065,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_clear(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_clear" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_clear" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   (arg1)->clear();
@@ -9076,7 +9076,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_get_allocator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_get_allocator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -9089,7 +9089,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_get_allocator(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_get_allocator" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_get_allocator" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = ((std::vector< double > const *)arg1)->get_allocator();
@@ -9100,7 +9100,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vdouble1d_t__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vdouble1d_T__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double >::size_type arg1 ;
   size_t val1 ;
@@ -9111,7 +9111,7 @@ SWIGINTERN PyObject *_wrap_new_vdouble1d_t__SWIG_2(PyObject *self, Py_ssize_t no
   if ((nobjs < 1) || (nobjs > 1)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vdouble1d_t" "', argument " "1"" of type '" "std::vector< double >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vdouble1d_T" "', argument " "1"" of type '" "std::vector< double >::size_type""'");
   } 
   arg1 = static_cast< std::vector< double >::size_type >(val1);
   result = (std::vector< double > *)new std::vector< double >(arg1);
@@ -9122,7 +9122,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_pop_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_pop_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -9134,7 +9134,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_pop_back(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_pop_back" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_pop_back" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   (arg1)->pop_back();
@@ -9145,7 +9145,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::size_type arg2 ;
@@ -9158,12 +9158,12 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_resize__SWIG_0(PyObject *self, Py_ssize_t
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_resize" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_resize" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t_resize" "', argument " "2"" of type '" "std::vector< double >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T_resize" "', argument " "2"" of type '" "std::vector< double >::size_type""'");
   } 
   arg2 = static_cast< std::vector< double >::size_type >(val2);
   (arg1)->resize(arg2);
@@ -9174,7 +9174,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::iterator arg2 ;
@@ -9188,18 +9188,18 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_erase__SWIG_0(PyObject *self, Py_ssize_t
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_erase" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_erase" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t_erase" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T_erase" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< double >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< double >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t_erase" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T_erase" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
     }
   }
   result = std_vector_Sl_double_Sg__erase__SWIG_0(arg1,SWIG_STD_MOVE(arg2));
@@ -9211,7 +9211,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::iterator arg2 ;
@@ -9228,29 +9228,29 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_erase__SWIG_1(PyObject *self, Py_ssize_t
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_erase" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_erase" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t_erase" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T_erase" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< double >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< double >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t_erase" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T_erase" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
     }
   }
   res3 = SWIG_ConvertPtr(swig_obj[2], SWIG_as_voidptrptr(&iter3), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res3) || !iter3) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t_erase" "', argument " "3"" of type '" "std::vector< double >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T_erase" "', argument " "3"" of type '" "std::vector< double >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< double >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< double >::iterator > *>(iter3);
     if (iter_t) {
       arg3 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t_erase" "', argument " "3"" of type '" "std::vector< double >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T_erase" "', argument " "3"" of type '" "std::vector< double >::iterator""'");
     }
   }
   result = std_vector_Sl_double_Sg__erase__SWIG_1(arg1,SWIG_STD_MOVE(arg2),SWIG_STD_MOVE(arg3));
@@ -9262,13 +9262,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_erase(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_erase(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_t_erase", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_T_erase", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -9279,7 +9279,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_erase(PyObject *self, PyObject *args) {
       int res = SWIG_ConvertPtr(argv[1], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
       _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< double >::iterator > *>(iter) != 0));
       if (_v) {
-        return _wrap_vdouble1d_t_erase__SWIG_0(self, argc, argv);
+        return _wrap_vdouble1d_T_erase__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -9296,14 +9296,14 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_erase(PyObject *self, PyObject *args) {
         int res = SWIG_ConvertPtr(argv[2], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
         _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< double >::iterator > *>(iter) != 0));
         if (_v) {
-          return _wrap_vdouble1d_t_erase__SWIG_1(self, argc, argv);
+          return _wrap_vdouble1d_T_erase__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_t_erase'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_T_erase'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< double >::erase(std::vector< double >::iterator)\n"
     "    std::vector< double >::erase(std::vector< double >::iterator,std::vector< double >::iterator)\n");
@@ -9311,7 +9311,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vdouble1d_t__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vdouble1d_T__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double >::size_type arg1 ;
   std::vector< double >::value_type *arg2 = 0 ;
@@ -9326,12 +9326,12 @@ SWIGINTERN PyObject *_wrap_new_vdouble1d_t__SWIG_3(PyObject *self, Py_ssize_t no
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vdouble1d_t" "', argument " "1"" of type '" "std::vector< double >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vdouble1d_T" "', argument " "1"" of type '" "std::vector< double >::size_type""'");
   } 
   arg1 = static_cast< std::vector< double >::size_type >(val1);
   ecode2 = SWIG_AsVal_double(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "new_vdouble1d_t" "', argument " "2"" of type '" "std::vector< double >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "new_vdouble1d_T" "', argument " "2"" of type '" "std::vector< double >::value_type""'");
   } 
   temp2 = static_cast< std::vector< double >::value_type >(val2);
   arg2 = &temp2;
@@ -9343,16 +9343,16 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vdouble1d_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_new_vdouble1d_T(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vdouble1d_t", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vdouble1d_T", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 0) {
-    return _wrap_new_vdouble1d_t__SWIG_0(self, argc, argv);
+    return _wrap_new_vdouble1d_T__SWIG_0(self, argc, argv);
   }
   if (argc == 1) {
     int _v = 0;
@@ -9361,7 +9361,7 @@ SWIGINTERN PyObject *_wrap_new_vdouble1d_t(PyObject *self, PyObject *args) {
       _v = SWIG_CheckState(res);
     }
     if (_v) {
-      return _wrap_new_vdouble1d_t__SWIG_2(self, argc, argv);
+      return _wrap_new_vdouble1d_T__SWIG_2(self, argc, argv);
     }
   }
   if (argc == 1) {
@@ -9369,7 +9369,7 @@ SWIGINTERN PyObject *_wrap_new_vdouble1d_t(PyObject *self, PyObject *args) {
     int res = swig::asptr(argv[0], (std::vector< double,std::allocator< double > >**)(0));
     _v = SWIG_CheckState(res);
     if (_v) {
-      return _wrap_new_vdouble1d_t__SWIG_1(self, argc, argv);
+      return _wrap_new_vdouble1d_T__SWIG_1(self, argc, argv);
     }
   }
   if (argc == 2) {
@@ -9384,13 +9384,13 @@ SWIGINTERN PyObject *_wrap_new_vdouble1d_t(PyObject *self, PyObject *args) {
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_new_vdouble1d_t__SWIG_3(self, argc, argv);
+        return _wrap_new_vdouble1d_T__SWIG_3(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vdouble1d_t'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vdouble1d_T'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< double >::vector()\n"
     "    std::vector< double >::vector(std::vector< double > const &)\n"
@@ -9400,7 +9400,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_push_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_push_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::value_type *arg2 = 0 ;
@@ -9412,15 +9412,15 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_push_back(PyObject *self, PyObject *args)
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_t_push_back", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_T_push_back", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_push_back" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_push_back" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_double(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t_push_back" "', argument " "2"" of type '" "std::vector< double >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T_push_back" "', argument " "2"" of type '" "std::vector< double >::value_type""'");
   } 
   temp2 = static_cast< std::vector< double >::value_type >(val2);
   arg2 = &temp2;
@@ -9432,7 +9432,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_front(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_front(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -9445,7 +9445,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_front(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_front" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_front" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = (std::vector< double >::value_type *) &((std::vector< double > const *)arg1)->front();
@@ -9457,7 +9457,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -9470,7 +9470,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_back(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_back" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_back" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = (std::vector< double >::value_type *) &((std::vector< double > const *)arg1)->back();
@@ -9482,7 +9482,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_assign(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_assign(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::size_type arg2 ;
@@ -9497,20 +9497,20 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_assign(PyObject *self, PyObject *args) {
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_t_assign", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_T_assign", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_assign" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_assign" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t_assign" "', argument " "2"" of type '" "std::vector< double >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T_assign" "', argument " "2"" of type '" "std::vector< double >::size_type""'");
   } 
   arg2 = static_cast< std::vector< double >::size_type >(val2);
   ecode3 = SWIG_AsVal_double(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_t_assign" "', argument " "3"" of type '" "std::vector< double >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_T_assign" "', argument " "3"" of type '" "std::vector< double >::value_type""'");
   } 
   temp3 = static_cast< std::vector< double >::value_type >(val3);
   arg3 = &temp3;
@@ -9522,7 +9522,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::size_type arg2 ;
@@ -9539,17 +9539,17 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_resize__SWIG_1(PyObject *self, Py_ssize_t
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_resize" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_resize" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t_resize" "', argument " "2"" of type '" "std::vector< double >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T_resize" "', argument " "2"" of type '" "std::vector< double >::size_type""'");
   } 
   arg2 = static_cast< std::vector< double >::size_type >(val2);
   ecode3 = SWIG_AsVal_double(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_t_resize" "', argument " "3"" of type '" "std::vector< double >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_T_resize" "', argument " "3"" of type '" "std::vector< double >::value_type""'");
   } 
   temp3 = static_cast< std::vector< double >::value_type >(val3);
   arg3 = &temp3;
@@ -9561,13 +9561,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_resize(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_resize(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_t_resize", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_T_resize", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -9579,7 +9579,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_resize(PyObject *self, PyObject *args) {
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vdouble1d_t_resize__SWIG_0(self, argc, argv);
+        return _wrap_vdouble1d_T_resize__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -9598,14 +9598,14 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_resize(PyObject *self, PyObject *args) {
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vdouble1d_t_resize__SWIG_1(self, argc, argv);
+          return _wrap_vdouble1d_T_resize__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_t_resize'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_T_resize'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< double >::resize(std::vector< double >::size_type)\n"
     "    std::vector< double >::resize(std::vector< double >::size_type,std::vector< double >::value_type const &)\n");
@@ -9613,7 +9613,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::iterator arg2 ;
@@ -9631,23 +9631,23 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_insert__SWIG_0(PyObject *self, Py_ssize_t
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_insert" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_insert" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t_insert" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T_insert" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< double >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< double >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t_insert" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T_insert" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_double(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_t_insert" "', argument " "3"" of type '" "std::vector< double >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_T_insert" "', argument " "3"" of type '" "std::vector< double >::value_type""'");
   } 
   temp3 = static_cast< std::vector< double >::value_type >(val3);
   arg3 = &temp3;
@@ -9660,7 +9660,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::iterator arg2 ;
@@ -9680,28 +9680,28 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_insert__SWIG_1(PyObject *self, Py_ssize_t
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_insert" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_insert" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t_insert" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T_insert" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< double >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< double >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t_insert" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T_insert" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_size_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_t_insert" "', argument " "3"" of type '" "std::vector< double >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_T_insert" "', argument " "3"" of type '" "std::vector< double >::size_type""'");
   } 
   arg3 = static_cast< std::vector< double >::size_type >(val3);
   ecode4 = SWIG_AsVal_double(swig_obj[3], &val4);
   if (!SWIG_IsOK(ecode4)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode4), "in method '" "vdouble1d_t_insert" "', argument " "4"" of type '" "std::vector< double >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode4), "in method '" "vdouble1d_T_insert" "', argument " "4"" of type '" "std::vector< double >::value_type""'");
   } 
   temp4 = static_cast< std::vector< double >::value_type >(val4);
   arg4 = &temp4;
@@ -9713,13 +9713,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_insert(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_insert(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_t_insert", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_T_insert", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -9735,7 +9735,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_insert(PyObject *self, PyObject *args) {
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vdouble1d_t_insert__SWIG_0(self, argc, argv);
+          return _wrap_vdouble1d_T_insert__SWIG_0(self, argc, argv);
         }
       }
     }
@@ -9759,7 +9759,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_insert(PyObject *self, PyObject *args) {
             _v = SWIG_CheckState(res);
           }
           if (_v) {
-            return _wrap_vdouble1d_t_insert__SWIG_1(self, argc, argv);
+            return _wrap_vdouble1d_T_insert__SWIG_1(self, argc, argv);
           }
         }
       }
@@ -9767,7 +9767,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_insert(PyObject *self, PyObject *args) {
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_t_insert'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_T_insert'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< double >::insert(std::vector< double >::iterator,std::vector< double >::value_type const &)\n"
     "    std::vector< double >::insert(std::vector< double >::iterator,std::vector< double >::size_type,std::vector< double >::value_type const &)\n");
@@ -9775,7 +9775,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_reserve(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_reserve(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::size_type arg2 ;
@@ -9786,15 +9786,15 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_reserve(PyObject *self, PyObject *args) {
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_t_reserve", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_T_reserve", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_reserve" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_reserve" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t_reserve" "', argument " "2"" of type '" "std::vector< double >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T_reserve" "', argument " "2"" of type '" "std::vector< double >::size_type""'");
   } 
   arg2 = static_cast< std::vector< double >::size_type >(val2);
   (arg1)->reserve(arg2);
@@ -9805,7 +9805,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_capacity(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_capacity(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -9818,7 +9818,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_capacity(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_capacity" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_capacity" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = ((std::vector< double > const *)arg1)->capacity();
@@ -9829,7 +9829,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_delete_vdouble1d_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_delete_vdouble1d_T(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -9841,7 +9841,7 @@ SWIGINTERN PyObject *_wrap_delete_vdouble1d_t(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, SWIG_POINTER_DISOWN |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vdouble1d_t" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vdouble1d_T" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   {
@@ -9862,18 +9862,18 @@ fail:
 }
 
 
-SWIGINTERN PyObject *vdouble1d_t_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vdouble1d_T_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   PyObject *obj;
   if (!SWIG_Python_UnpackTuple(args, "swigregister", 1, 1, &obj)) return NULL;
   SWIG_TypeNewClientData(SWIGTYPE_p_std__vectorT_double_t, SWIG_NewClientData(obj));
   return SWIG_Py_Void();
 }
 
-SWIGINTERN PyObject *vdouble1d_t_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vdouble1d_T_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   return SWIG_Python_InitShadowInstance(args);
 }
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_iterator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_iterator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   PyObject **arg2 = (PyObject **) 0 ;
@@ -9888,7 +9888,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_iterator(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_iterator" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_iterator" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = (swig::SwigPyIterator *)std_vector_Sl_std_vector_Sl_double_Sg__Sg__iterator(arg1,arg2);
@@ -9899,7 +9899,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___nonzero__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___nonzero__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -9912,7 +9912,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___nonzero__(PyObject *self, PyObject *arg
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___nonzero__" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___nonzero__" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = (bool)std_vector_Sl_std_vector_Sl_double_Sg__Sg____nonzero__((std::vector< std::vector< double > > const *)arg1);
@@ -9923,7 +9923,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___bool__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___bool__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -9936,7 +9936,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___bool__(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___bool__" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___bool__" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = (bool)std_vector_Sl_std_vector_Sl_double_Sg__Sg____bool__((std::vector< std::vector< double > > const *)arg1);
@@ -9947,7 +9947,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___len__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___len__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -9960,7 +9960,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___len__(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___len__" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___len__" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = std_vector_Sl_std_vector_Sl_double_Sg__Sg____len__((std::vector< std::vector< double > > const *)arg1);
@@ -9971,7 +9971,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___getslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___getslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::difference_type arg2 ;
@@ -9986,20 +9986,20 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___getslice__(PyObject *self, PyObject *ar
   std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > *result = 0 ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_t___getslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_T___getslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___getslice__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___getslice__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_t___getslice__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_T___getslice__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble2d_t___getslice__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble2d_T___getslice__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::vector< double > >::difference_type >(val3);
   try {
@@ -10016,7 +10016,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::difference_type arg2 ;
@@ -10032,17 +10032,17 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setslice____SWIG_0(PyObject *self, Py_s
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___setslice__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___setslice__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_t___setslice__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_T___setslice__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble2d_t___setslice__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble2d_T___setslice__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::vector< double > >::difference_type >(val3);
   try {
@@ -10059,7 +10059,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::difference_type arg2 ;
@@ -10077,27 +10077,27 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setslice____SWIG_1(PyObject *self, Py_s
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___setslice__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___setslice__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_t___setslice__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_T___setslice__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble2d_t___setslice__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble2d_T___setslice__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::vector< double > >::difference_type >(val3);
   {
     std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > *ptr = (std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > *)0;
     res4 = swig::asptr(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vdouble2d_t___setslice__" "', argument " "4"" of type '" "std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vdouble2d_T___setslice__" "', argument " "4"" of type '" "std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_t___setslice__" "', argument " "4"" of type '" "std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_T___setslice__" "', argument " "4"" of type '" "std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > const &""'"); 
     }
     arg4 = ptr;
   }
@@ -10117,13 +10117,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___setslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___setslice__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_t___setslice__", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_T___setslice__", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -10140,7 +10140,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setslice__(PyObject *self, PyObject *ar
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vdouble2d_t___setslice____SWIG_0(self, argc, argv);
+          return _wrap_vdouble2d_T___setslice____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -10163,7 +10163,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setslice__(PyObject *self, PyObject *ar
           int res = swig::asptr(argv[3], (std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > >**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vdouble2d_t___setslice____SWIG_1(self, argc, argv);
+            return _wrap_vdouble2d_T___setslice____SWIG_1(self, argc, argv);
           }
         }
       }
@@ -10171,7 +10171,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setslice__(PyObject *self, PyObject *ar
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_t___setslice__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_T___setslice__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< double > >::__setslice__(std::vector< std::vector< double > >::difference_type,std::vector< std::vector< double > >::difference_type)\n"
     "    std::vector< std::vector< double > >::__setslice__(std::vector< std::vector< double > >::difference_type,std::vector< std::vector< double > >::difference_type,std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > const &)\n");
@@ -10179,7 +10179,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___delslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___delslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::difference_type arg2 ;
@@ -10193,20 +10193,20 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___delslice__(PyObject *self, PyObject *ar
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_t___delslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_T___delslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___delslice__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___delslice__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_t___delslice__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_T___delslice__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble2d_t___delslice__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble2d_T___delslice__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::vector< double > >::difference_type >(val3);
   try {
@@ -10223,7 +10223,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::difference_type arg2 ;
@@ -10236,12 +10236,12 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___delitem____SWIG_0(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___delitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___delitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_t___delitem__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_T___delitem__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< double > >::difference_type >(val2);
   try {
@@ -10258,7 +10258,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -10270,12 +10270,12 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___getitem____SWIG_0(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___getitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___getitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -10293,7 +10293,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -10306,12 +10306,12 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setitem____SWIG_0(PyObject *self, Py_ss
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -10319,10 +10319,10 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setitem____SWIG_0(PyObject *self, Py_ss
     std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > *ptr = (std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble2d_t___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble2d_T___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_t___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_T___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > const &""'"); 
     }
     arg3 = ptr;
   }
@@ -10342,7 +10342,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -10353,12 +10353,12 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setitem____SWIG_1(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -10376,7 +10376,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -10387,12 +10387,12 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___delitem____SWIG_1(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___delitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___delitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -10410,13 +10410,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___delitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___delitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_t___delitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_T___delitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -10427,7 +10427,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___delitem__(PyObject *self, PyObject *arg
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vdouble2d_t___delitem____SWIG_1(self, argc, argv);
+        return _wrap_vdouble2d_T___delitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -10441,13 +10441,13 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___delitem__(PyObject *self, PyObject *arg
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vdouble2d_t___delitem____SWIG_0(self, argc, argv);
+        return _wrap_vdouble2d_T___delitem____SWIG_0(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_t___delitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_T___delitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< double > >::__delitem__(std::vector< std::vector< double > >::difference_type)\n"
     "    std::vector< std::vector< double > >::__delitem__(SWIGPY_SLICEOBJECT *)\n");
@@ -10455,7 +10455,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::difference_type arg2 ;
@@ -10469,12 +10469,12 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___getitem____SWIG_1(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___getitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___getitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_t___getitem__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_T___getitem__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< double > >::difference_type >(val2);
   try {
@@ -10490,13 +10490,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___getitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___getitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_t___getitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_T___getitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -10507,7 +10507,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___getitem__(PyObject *self, PyObject *arg
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vdouble2d_t___getitem____SWIG_0(self, argc, argv);
+        return _wrap_vdouble2d_T___getitem____SWIG_0(self, argc, argv);
       }
     }
   }
@@ -10521,13 +10521,13 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___getitem__(PyObject *self, PyObject *arg
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vdouble2d_t___getitem____SWIG_1(self, argc, argv);
+        return _wrap_vdouble2d_T___getitem____SWIG_1(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_t___getitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_T___getitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< double > >::__getitem__(SWIGPY_SLICEOBJECT *)\n"
     "    std::vector< std::vector< double > >::__getitem__(std::vector< std::vector< double > >::difference_type) const\n");
@@ -10535,7 +10535,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::difference_type arg2 ;
@@ -10550,22 +10550,22 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setitem____SWIG_2(PyObject *self, Py_ss
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_t___setitem__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_T___setitem__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< double > >::difference_type >(val2);
   {
     std::vector< double,std::allocator< double > > *ptr = (std::vector< double,std::allocator< double > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble2d_t___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble2d_T___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_t___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_T___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -10583,13 +10583,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___setitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___setitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_t___setitem__", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_T___setitem__", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -10600,7 +10600,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setitem__(PyObject *self, PyObject *arg
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vdouble2d_t___setitem____SWIG_1(self, argc, argv);
+        return _wrap_vdouble2d_T___setitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -10616,7 +10616,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setitem__(PyObject *self, PyObject *arg
         int res = swig::asptr(argv[2], (std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vdouble2d_t___setitem____SWIG_0(self, argc, argv);
+          return _wrap_vdouble2d_T___setitem____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -10634,14 +10634,14 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setitem__(PyObject *self, PyObject *arg
         int res = swig::asptr(argv[2], (std::vector< double,std::allocator< double > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vdouble2d_t___setitem____SWIG_2(self, argc, argv);
+          return _wrap_vdouble2d_T___setitem____SWIG_2(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_t___setitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_T___setitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< double > >::__setitem__(SWIGPY_SLICEOBJECT *,std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > const &)\n"
     "    std::vector< std::vector< double > >::__setitem__(SWIGPY_SLICEOBJECT *)\n"
@@ -10650,7 +10650,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_pop(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_pop(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -10663,7 +10663,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_pop(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_pop" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_pop" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   try {
@@ -10678,7 +10678,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_append(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_append(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::value_type *arg2 = 0 ;
@@ -10688,20 +10688,20 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_append(PyObject *self, PyObject *args) {
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_t_append", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_T_append", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_append" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_append" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   {
     std::vector< double,std::allocator< double > > *ptr = (std::vector< double,std::allocator< double > > *)0;
     res2 = swig::asptr(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vdouble2d_t_append" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vdouble2d_T_append" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_t_append" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_T_append" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -10715,7 +10715,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vdouble2d_t__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
+SWIGINTERN PyObject *_wrap_new_vdouble2d_T__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *result = 0 ;
   
@@ -10729,7 +10729,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vdouble2d_t__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vdouble2d_T__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double,std::allocator< double > > > *arg1 = 0 ;
   int res1 = SWIG_OLDOBJ ;
@@ -10741,10 +10741,10 @@ SWIGINTERN PyObject *_wrap_new_vdouble2d_t__SWIG_1(PyObject *self, Py_ssize_t no
     std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > *ptr = (std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > *)0;
     res1 = swig::asptr(swig_obj[0], &ptr);
     if (!SWIG_IsOK(res1)) {
-      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vdouble2d_t" "', argument " "1"" of type '" "std::vector< std::vector< double,std::allocator< double > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vdouble2d_T" "', argument " "1"" of type '" "std::vector< std::vector< double,std::allocator< double > > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vdouble2d_t" "', argument " "1"" of type '" "std::vector< std::vector< double,std::allocator< double > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vdouble2d_T" "', argument " "1"" of type '" "std::vector< std::vector< double,std::allocator< double > > > const &""'"); 
     }
     arg1 = ptr;
   }
@@ -10758,7 +10758,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_empty(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_empty(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -10771,7 +10771,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_empty(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_empty" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_empty" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = (bool)((std::vector< std::vector< double > > const *)arg1)->empty();
@@ -10782,7 +10782,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_size(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_size(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -10795,7 +10795,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_size(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_size" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_size" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = ((std::vector< std::vector< double > > const *)arg1)->size();
@@ -10806,7 +10806,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_swap(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_swap(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double,std::allocator< double > > > *arg2 = 0 ;
@@ -10817,18 +10817,18 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_swap(PyObject *self, PyObject *args) {
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_t_swap", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_T_swap", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_swap" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_swap" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], &argp2, SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t,  0 );
   if (!SWIG_IsOK(res2)) {
-    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vdouble2d_t_swap" "', argument " "2"" of type '" "std::vector< std::vector< double,std::allocator< double > > > &""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vdouble2d_T_swap" "', argument " "2"" of type '" "std::vector< std::vector< double,std::allocator< double > > > &""'"); 
   }
   if (!argp2) {
-    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_t_swap" "', argument " "2"" of type '" "std::vector< std::vector< double,std::allocator< double > > > &""'"); 
+    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_T_swap" "', argument " "2"" of type '" "std::vector< std::vector< double,std::allocator< double > > > &""'"); 
   }
   arg2 = reinterpret_cast< std::vector< std::vector< double,std::allocator< double > > > * >(argp2);
   (arg1)->swap(*arg2);
@@ -10839,7 +10839,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_begin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_begin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -10852,7 +10852,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_begin(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_begin" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_begin" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = (arg1)->begin();
@@ -10864,7 +10864,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_end(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_end(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -10877,7 +10877,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_end(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_end" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_end" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = (arg1)->end();
@@ -10889,7 +10889,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_rbegin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_rbegin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -10902,7 +10902,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_rbegin(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_rbegin" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_rbegin" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = (arg1)->rbegin();
@@ -10914,7 +10914,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_rend(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_rend(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -10927,7 +10927,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_rend(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_rend" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_rend" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = (arg1)->rend();
@@ -10939,7 +10939,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_clear(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_clear(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -10951,7 +10951,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_clear(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_clear" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_clear" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   (arg1)->clear();
@@ -10962,7 +10962,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_get_allocator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_get_allocator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -10975,7 +10975,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_get_allocator(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_get_allocator" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_get_allocator" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = ((std::vector< std::vector< double > > const *)arg1)->get_allocator();
@@ -10986,7 +10986,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vdouble2d_t__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vdouble2d_T__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > >::size_type arg1 ;
   size_t val1 ;
@@ -10997,7 +10997,7 @@ SWIGINTERN PyObject *_wrap_new_vdouble2d_t__SWIG_2(PyObject *self, Py_ssize_t no
   if ((nobjs < 1) || (nobjs > 1)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vdouble2d_t" "', argument " "1"" of type '" "std::vector< std::vector< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vdouble2d_T" "', argument " "1"" of type '" "std::vector< std::vector< double > >::size_type""'");
   } 
   arg1 = static_cast< std::vector< std::vector< double > >::size_type >(val1);
   result = (std::vector< std::vector< double > > *)new std::vector< std::vector< double > >(arg1);
@@ -11008,7 +11008,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_pop_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_pop_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -11020,7 +11020,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_pop_back(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_pop_back" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_pop_back" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   (arg1)->pop_back();
@@ -11031,7 +11031,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::size_type arg2 ;
@@ -11044,12 +11044,12 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_resize__SWIG_0(PyObject *self, Py_ssize_t
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_resize" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_resize" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_t_resize" "', argument " "2"" of type '" "std::vector< std::vector< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_T_resize" "', argument " "2"" of type '" "std::vector< std::vector< double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< double > >::size_type >(val2);
   (arg1)->resize(arg2);
@@ -11060,7 +11060,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::iterator arg2 ;
@@ -11074,18 +11074,18 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_erase__SWIG_0(PyObject *self, Py_ssize_t
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_erase" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_erase" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t_erase" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T_erase" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t_erase" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T_erase" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
     }
   }
   result = std_vector_Sl_std_vector_Sl_double_Sg__Sg__erase__SWIG_0(arg1,SWIG_STD_MOVE(arg2));
@@ -11097,7 +11097,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::iterator arg2 ;
@@ -11114,29 +11114,29 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_erase__SWIG_1(PyObject *self, Py_ssize_t
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_erase" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_erase" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t_erase" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T_erase" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t_erase" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T_erase" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
     }
   }
   res3 = SWIG_ConvertPtr(swig_obj[2], SWIG_as_voidptrptr(&iter3), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res3) || !iter3) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t_erase" "', argument " "3"" of type '" "std::vector< std::vector< double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T_erase" "', argument " "3"" of type '" "std::vector< std::vector< double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *>(iter3);
     if (iter_t) {
       arg3 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t_erase" "', argument " "3"" of type '" "std::vector< std::vector< double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T_erase" "', argument " "3"" of type '" "std::vector< std::vector< double > >::iterator""'");
     }
   }
   result = std_vector_Sl_std_vector_Sl_double_Sg__Sg__erase__SWIG_1(arg1,SWIG_STD_MOVE(arg2),SWIG_STD_MOVE(arg3));
@@ -11148,13 +11148,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_erase(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_erase(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_t_erase", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_T_erase", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -11165,7 +11165,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_erase(PyObject *self, PyObject *args) {
       int res = SWIG_ConvertPtr(argv[1], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
       _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *>(iter) != 0));
       if (_v) {
-        return _wrap_vdouble2d_t_erase__SWIG_0(self, argc, argv);
+        return _wrap_vdouble2d_T_erase__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -11182,14 +11182,14 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_erase(PyObject *self, PyObject *args) {
         int res = SWIG_ConvertPtr(argv[2], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
         _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *>(iter) != 0));
         if (_v) {
-          return _wrap_vdouble2d_t_erase__SWIG_1(self, argc, argv);
+          return _wrap_vdouble2d_T_erase__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_t_erase'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_T_erase'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< double > >::erase(std::vector< std::vector< double > >::iterator)\n"
     "    std::vector< std::vector< double > >::erase(std::vector< std::vector< double > >::iterator,std::vector< std::vector< double > >::iterator)\n");
@@ -11197,7 +11197,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vdouble2d_t__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vdouble2d_T__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > >::size_type arg1 ;
   std::vector< std::vector< double > >::value_type *arg2 = 0 ;
@@ -11210,17 +11210,17 @@ SWIGINTERN PyObject *_wrap_new_vdouble2d_t__SWIG_3(PyObject *self, Py_ssize_t no
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vdouble2d_t" "', argument " "1"" of type '" "std::vector< std::vector< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vdouble2d_T" "', argument " "1"" of type '" "std::vector< std::vector< double > >::size_type""'");
   } 
   arg1 = static_cast< std::vector< std::vector< double > >::size_type >(val1);
   {
     std::vector< double,std::allocator< double > > *ptr = (std::vector< double,std::allocator< double > > *)0;
     res2 = swig::asptr(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "new_vdouble2d_t" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "new_vdouble2d_T" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vdouble2d_t" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vdouble2d_T" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -11234,16 +11234,16 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vdouble2d_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_new_vdouble2d_T(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vdouble2d_t", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vdouble2d_T", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 0) {
-    return _wrap_new_vdouble2d_t__SWIG_0(self, argc, argv);
+    return _wrap_new_vdouble2d_T__SWIG_0(self, argc, argv);
   }
   if (argc == 1) {
     int _v = 0;
@@ -11252,7 +11252,7 @@ SWIGINTERN PyObject *_wrap_new_vdouble2d_t(PyObject *self, PyObject *args) {
       _v = SWIG_CheckState(res);
     }
     if (_v) {
-      return _wrap_new_vdouble2d_t__SWIG_2(self, argc, argv);
+      return _wrap_new_vdouble2d_T__SWIG_2(self, argc, argv);
     }
   }
   if (argc == 1) {
@@ -11260,7 +11260,7 @@ SWIGINTERN PyObject *_wrap_new_vdouble2d_t(PyObject *self, PyObject *args) {
     int res = swig::asptr(argv[0], (std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > >**)(0));
     _v = SWIG_CheckState(res);
     if (_v) {
-      return _wrap_new_vdouble2d_t__SWIG_1(self, argc, argv);
+      return _wrap_new_vdouble2d_T__SWIG_1(self, argc, argv);
     }
   }
   if (argc == 2) {
@@ -11273,13 +11273,13 @@ SWIGINTERN PyObject *_wrap_new_vdouble2d_t(PyObject *self, PyObject *args) {
       int res = swig::asptr(argv[1], (std::vector< double,std::allocator< double > >**)(0));
       _v = SWIG_CheckState(res);
       if (_v) {
-        return _wrap_new_vdouble2d_t__SWIG_3(self, argc, argv);
+        return _wrap_new_vdouble2d_T__SWIG_3(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vdouble2d_t'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vdouble2d_T'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< double > >::vector()\n"
     "    std::vector< std::vector< double > >::vector(std::vector< std::vector< double,std::allocator< double > > > const &)\n"
@@ -11289,7 +11289,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_push_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_push_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::value_type *arg2 = 0 ;
@@ -11299,20 +11299,20 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_push_back(PyObject *self, PyObject *args)
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_t_push_back", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_T_push_back", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_push_back" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_push_back" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   {
     std::vector< double,std::allocator< double > > *ptr = (std::vector< double,std::allocator< double > > *)0;
     res2 = swig::asptr(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vdouble2d_t_push_back" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vdouble2d_T_push_back" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_t_push_back" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_T_push_back" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -11326,7 +11326,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_front(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_front(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -11339,7 +11339,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_front(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_front" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_front" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = (std::vector< std::vector< double > >::value_type *) &((std::vector< std::vector< double > > const *)arg1)->front();
@@ -11351,7 +11351,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -11364,7 +11364,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_back(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_back" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_back" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = (std::vector< std::vector< double > >::value_type *) &((std::vector< std::vector< double > > const *)arg1)->back();
@@ -11376,7 +11376,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_assign(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_assign(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::size_type arg2 ;
@@ -11389,25 +11389,25 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_assign(PyObject *self, PyObject *args) {
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_t_assign", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_T_assign", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_assign" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_assign" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_t_assign" "', argument " "2"" of type '" "std::vector< std::vector< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_T_assign" "', argument " "2"" of type '" "std::vector< std::vector< double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< double > >::size_type >(val2);
   {
     std::vector< double,std::allocator< double > > *ptr = (std::vector< double,std::allocator< double > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble2d_t_assign" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble2d_T_assign" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_t_assign" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_T_assign" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -11421,7 +11421,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::size_type arg2 ;
@@ -11436,22 +11436,22 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_resize__SWIG_1(PyObject *self, Py_ssize_t
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_resize" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_resize" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_t_resize" "', argument " "2"" of type '" "std::vector< std::vector< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_T_resize" "', argument " "2"" of type '" "std::vector< std::vector< double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< double > >::size_type >(val2);
   {
     std::vector< double,std::allocator< double > > *ptr = (std::vector< double,std::allocator< double > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble2d_t_resize" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble2d_T_resize" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_t_resize" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_T_resize" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -11465,13 +11465,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_resize(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_resize(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_t_resize", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_T_resize", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -11483,7 +11483,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_resize(PyObject *self, PyObject *args) {
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vdouble2d_t_resize__SWIG_0(self, argc, argv);
+        return _wrap_vdouble2d_T_resize__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -11500,14 +11500,14 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_resize(PyObject *self, PyObject *args) {
         int res = swig::asptr(argv[2], (std::vector< double,std::allocator< double > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vdouble2d_t_resize__SWIG_1(self, argc, argv);
+          return _wrap_vdouble2d_T_resize__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_t_resize'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_T_resize'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< double > >::resize(std::vector< std::vector< double > >::size_type)\n"
     "    std::vector< std::vector< double > >::resize(std::vector< std::vector< double > >::size_type,std::vector< std::vector< double > >::value_type const &)\n");
@@ -11515,7 +11515,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::iterator arg2 ;
@@ -11531,28 +11531,28 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_insert__SWIG_0(PyObject *self, Py_ssize_t
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_insert" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_insert" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t_insert" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T_insert" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t_insert" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T_insert" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
     }
   }
   {
     std::vector< double,std::allocator< double > > *ptr = (std::vector< double,std::allocator< double > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble2d_t_insert" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble2d_T_insert" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_t_insert" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_T_insert" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -11567,7 +11567,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::iterator arg2 ;
@@ -11585,33 +11585,33 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_insert__SWIG_1(PyObject *self, Py_ssize_t
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_insert" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_insert" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t_insert" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T_insert" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t_insert" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T_insert" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_size_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble2d_t_insert" "', argument " "3"" of type '" "std::vector< std::vector< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble2d_T_insert" "', argument " "3"" of type '" "std::vector< std::vector< double > >::size_type""'");
   } 
   arg3 = static_cast< std::vector< std::vector< double > >::size_type >(val3);
   {
     std::vector< double,std::allocator< double > > *ptr = (std::vector< double,std::allocator< double > > *)0;
     res4 = swig::asptr(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vdouble2d_t_insert" "', argument " "4"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vdouble2d_T_insert" "', argument " "4"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_t_insert" "', argument " "4"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_T_insert" "', argument " "4"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     arg4 = ptr;
   }
@@ -11625,13 +11625,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_insert(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_insert(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_t_insert", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_T_insert", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -11645,7 +11645,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_insert(PyObject *self, PyObject *args) {
         int res = swig::asptr(argv[2], (std::vector< double,std::allocator< double > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vdouble2d_t_insert__SWIG_0(self, argc, argv);
+          return _wrap_vdouble2d_T_insert__SWIG_0(self, argc, argv);
         }
       }
     }
@@ -11667,7 +11667,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_insert(PyObject *self, PyObject *args) {
           int res = swig::asptr(argv[3], (std::vector< double,std::allocator< double > >**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vdouble2d_t_insert__SWIG_1(self, argc, argv);
+            return _wrap_vdouble2d_T_insert__SWIG_1(self, argc, argv);
           }
         }
       }
@@ -11675,7 +11675,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_insert(PyObject *self, PyObject *args) {
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_t_insert'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_T_insert'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< double > >::insert(std::vector< std::vector< double > >::iterator,std::vector< std::vector< double > >::value_type const &)\n"
     "    std::vector< std::vector< double > >::insert(std::vector< std::vector< double > >::iterator,std::vector< std::vector< double > >::size_type,std::vector< std::vector< double > >::value_type const &)\n");
@@ -11683,7 +11683,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_reserve(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_reserve(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::size_type arg2 ;
@@ -11694,15 +11694,15 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_reserve(PyObject *self, PyObject *args) {
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_t_reserve", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_T_reserve", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_reserve" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_reserve" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_t_reserve" "', argument " "2"" of type '" "std::vector< std::vector< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_T_reserve" "', argument " "2"" of type '" "std::vector< std::vector< double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< double > >::size_type >(val2);
   (arg1)->reserve(arg2);
@@ -11713,7 +11713,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_capacity(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_capacity(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -11726,7 +11726,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_capacity(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_capacity" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_capacity" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = ((std::vector< std::vector< double > > const *)arg1)->capacity();
@@ -11737,7 +11737,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_delete_vdouble2d_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_delete_vdouble2d_T(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -11749,7 +11749,7 @@ SWIGINTERN PyObject *_wrap_delete_vdouble2d_t(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, SWIG_POINTER_DISOWN |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vdouble2d_t" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vdouble2d_T" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   {
@@ -11770,18 +11770,18 @@ fail:
 }
 
 
-SWIGINTERN PyObject *vdouble2d_t_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vdouble2d_T_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   PyObject *obj;
   if (!SWIG_Python_UnpackTuple(args, "swigregister", 1, 1, &obj)) return NULL;
   SWIG_TypeNewClientData(SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, SWIG_NewClientData(obj));
   return SWIG_Py_Void();
 }
 
-SWIGINTERN PyObject *vdouble2d_t_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vdouble2d_T_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   return SWIG_Python_InitShadowInstance(args);
 }
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_iterator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_iterator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   PyObject **arg2 = (PyObject **) 0 ;
@@ -11796,7 +11796,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_iterator(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_iterator" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_iterator" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = (swig::SwigPyIterator *)std_vector_Sl_int_Sg__iterator(arg1,arg2);
@@ -11807,7 +11807,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___nonzero__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___nonzero__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -11820,7 +11820,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___nonzero__(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___nonzero__" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___nonzero__" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = (bool)std_vector_Sl_int_Sg____nonzero__((std::vector< int > const *)arg1);
@@ -11831,7 +11831,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___bool__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___bool__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -11844,7 +11844,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___bool__(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___bool__" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___bool__" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = (bool)std_vector_Sl_int_Sg____bool__((std::vector< int > const *)arg1);
@@ -11855,7 +11855,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___len__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___len__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -11868,7 +11868,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___len__(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___len__" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___len__" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = std_vector_Sl_int_Sg____len__((std::vector< int > const *)arg1);
@@ -11879,7 +11879,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___getslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___getslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::difference_type arg2 ;
@@ -11894,20 +11894,20 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___getslice__(PyObject *self, PyObjec
   std::vector< int,std::allocator< int > > *result = 0 ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_integer_t___getslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_integer_T___getslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___getslice__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___getslice__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t___getslice__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T___getslice__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< int >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_t___getslice__" "', argument " "3"" of type '" "std::vector< int >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_T___getslice__" "', argument " "3"" of type '" "std::vector< int >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< int >::difference_type >(val3);
   try {
@@ -11924,7 +11924,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::difference_type arg2 ;
@@ -11940,17 +11940,17 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setslice____SWIG_0(PyObject *self,
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___setslice__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___setslice__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t___setslice__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T___setslice__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< int >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_t___setslice__" "', argument " "3"" of type '" "std::vector< int >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_T___setslice__" "', argument " "3"" of type '" "std::vector< int >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< int >::difference_type >(val3);
   try {
@@ -11967,7 +11967,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::difference_type arg2 ;
@@ -11985,27 +11985,27 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setslice____SWIG_1(PyObject *self,
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___setslice__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___setslice__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t___setslice__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T___setslice__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< int >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_t___setslice__" "', argument " "3"" of type '" "std::vector< int >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_T___setslice__" "', argument " "3"" of type '" "std::vector< int >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< int >::difference_type >(val3);
   {
     std::vector< int,std::allocator< int > > *ptr = (std::vector< int,std::allocator< int > > *)0;
     res4 = swig::asptr(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_integer_t___setslice__" "', argument " "4"" of type '" "std::vector< int,std::allocator< int > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_integer_T___setslice__" "', argument " "4"" of type '" "std::vector< int,std::allocator< int > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_integer_t___setslice__" "', argument " "4"" of type '" "std::vector< int,std::allocator< int > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_integer_T___setslice__" "', argument " "4"" of type '" "std::vector< int,std::allocator< int > > const &""'"); 
     }
     arg4 = ptr;
   }
@@ -12025,13 +12025,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___setslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___setslice__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_t___setslice__", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_T___setslice__", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -12048,7 +12048,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setslice__(PyObject *self, PyObjec
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_integer_t___setslice____SWIG_0(self, argc, argv);
+          return _wrap_vector_integer_T___setslice____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -12071,7 +12071,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setslice__(PyObject *self, PyObjec
           int res = swig::asptr(argv[3], (std::vector< int,std::allocator< int > >**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vector_integer_t___setslice____SWIG_1(self, argc, argv);
+            return _wrap_vector_integer_T___setslice____SWIG_1(self, argc, argv);
           }
         }
       }
@@ -12079,7 +12079,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setslice__(PyObject *self, PyObjec
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_t___setslice__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_T___setslice__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< int >::__setslice__(std::vector< int >::difference_type,std::vector< int >::difference_type)\n"
     "    std::vector< int >::__setslice__(std::vector< int >::difference_type,std::vector< int >::difference_type,std::vector< int,std::allocator< int > > const &)\n");
@@ -12087,7 +12087,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___delslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___delslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::difference_type arg2 ;
@@ -12101,20 +12101,20 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___delslice__(PyObject *self, PyObjec
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_integer_t___delslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_integer_T___delslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___delslice__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___delslice__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t___delslice__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T___delslice__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< int >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_t___delslice__" "', argument " "3"" of type '" "std::vector< int >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_T___delslice__" "', argument " "3"" of type '" "std::vector< int >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< int >::difference_type >(val3);
   try {
@@ -12131,7 +12131,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::difference_type arg2 ;
@@ -12144,12 +12144,12 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___delitem____SWIG_0(PyObject *self,
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___delitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___delitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t___delitem__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T___delitem__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< int >::difference_type >(val2);
   try {
@@ -12166,7 +12166,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -12178,12 +12178,12 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___getitem____SWIG_0(PyObject *self,
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___getitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___getitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -12201,7 +12201,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -12214,12 +12214,12 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setitem____SWIG_0(PyObject *self,
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___setitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___setitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -12227,10 +12227,10 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setitem____SWIG_0(PyObject *self,
     std::vector< int,std::allocator< int > > *ptr = (std::vector< int,std::allocator< int > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_integer_t___setitem__" "', argument " "3"" of type '" "std::vector< int,std::allocator< int > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_integer_T___setitem__" "', argument " "3"" of type '" "std::vector< int,std::allocator< int > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_integer_t___setitem__" "', argument " "3"" of type '" "std::vector< int,std::allocator< int > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_integer_T___setitem__" "', argument " "3"" of type '" "std::vector< int,std::allocator< int > > const &""'"); 
     }
     arg3 = ptr;
   }
@@ -12250,7 +12250,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -12261,12 +12261,12 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setitem____SWIG_1(PyObject *self,
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___setitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___setitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -12284,7 +12284,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -12295,12 +12295,12 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___delitem____SWIG_1(PyObject *self,
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___delitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___delitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -12318,13 +12318,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___delitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___delitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_t___delitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_T___delitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -12335,7 +12335,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___delitem__(PyObject *self, PyObject
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_integer_t___delitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_integer_T___delitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -12349,13 +12349,13 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___delitem__(PyObject *self, PyObject
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_integer_t___delitem____SWIG_0(self, argc, argv);
+        return _wrap_vector_integer_T___delitem____SWIG_0(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_t___delitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_T___delitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< int >::__delitem__(std::vector< int >::difference_type)\n"
     "    std::vector< int >::__delitem__(SWIGPY_SLICEOBJECT *)\n");
@@ -12363,7 +12363,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::difference_type arg2 ;
@@ -12377,12 +12377,12 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___getitem____SWIG_1(PyObject *self,
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___getitem__" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___getitem__" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t___getitem__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T___getitem__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< int >::difference_type >(val2);
   try {
@@ -12398,13 +12398,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___getitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___getitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_t___getitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_T___getitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -12415,7 +12415,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___getitem__(PyObject *self, PyObject
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_integer_t___getitem____SWIG_0(self, argc, argv);
+        return _wrap_vector_integer_T___getitem____SWIG_0(self, argc, argv);
       }
     }
   }
@@ -12429,13 +12429,13 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___getitem__(PyObject *self, PyObject
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_integer_t___getitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_integer_T___getitem____SWIG_1(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_t___getitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_T___getitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< int >::__getitem__(SWIGPY_SLICEOBJECT *)\n"
     "    std::vector< int >::__getitem__(std::vector< int >::difference_type) const\n");
@@ -12443,7 +12443,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::difference_type arg2 ;
@@ -12460,17 +12460,17 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setitem____SWIG_2(PyObject *self,
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___setitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___setitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t___setitem__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T___setitem__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< int >::difference_type >(val2);
   ecode3 = SWIG_AsVal_int(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_t___setitem__" "', argument " "3"" of type '" "std::vector< int >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_T___setitem__" "', argument " "3"" of type '" "std::vector< int >::value_type""'");
   } 
   temp3 = static_cast< std::vector< int >::value_type >(val3);
   arg3 = &temp3;
@@ -12486,13 +12486,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___setitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___setitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_t___setitem__", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_T___setitem__", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -12503,7 +12503,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setitem__(PyObject *self, PyObject
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_integer_t___setitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_integer_T___setitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -12519,7 +12519,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setitem__(PyObject *self, PyObject
         int res = swig::asptr(argv[2], (std::vector< int,std::allocator< int > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vector_integer_t___setitem____SWIG_0(self, argc, argv);
+          return _wrap_vector_integer_T___setitem____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -12539,14 +12539,14 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setitem__(PyObject *self, PyObject
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_integer_t___setitem____SWIG_2(self, argc, argv);
+          return _wrap_vector_integer_T___setitem____SWIG_2(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_t___setitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_T___setitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< int >::__setitem__(SWIGPY_SLICEOBJECT *,std::vector< int,std::allocator< int > > const &)\n"
     "    std::vector< int >::__setitem__(SWIGPY_SLICEOBJECT *)\n"
@@ -12555,7 +12555,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_pop(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_pop(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -12568,7 +12568,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_pop(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_pop" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_pop" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   try {
@@ -12583,7 +12583,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_append(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_append(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::value_type *arg2 = 0 ;
@@ -12595,15 +12595,15 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_append(PyObject *self, PyObject *arg
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_integer_t_append", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_integer_T_append", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_append" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_append" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_int(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t_append" "', argument " "2"" of type '" "std::vector< int >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T_append" "', argument " "2"" of type '" "std::vector< int >::value_type""'");
   } 
   temp2 = static_cast< std::vector< int >::value_type >(val2);
   arg2 = &temp2;
@@ -12615,7 +12615,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_integer_t__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
+SWIGINTERN PyObject *_wrap_new_vector_integer_T__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
   PyObject *resultobj = 0;
   std::vector< int > *result = 0 ;
   
@@ -12629,7 +12629,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_integer_t__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_integer_T__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = 0 ;
   int res1 = SWIG_OLDOBJ ;
@@ -12641,10 +12641,10 @@ SWIGINTERN PyObject *_wrap_new_vector_integer_t__SWIG_1(PyObject *self, Py_ssize
     std::vector< int,std::allocator< int > > *ptr = (std::vector< int,std::allocator< int > > *)0;
     res1 = swig::asptr(swig_obj[0], &ptr);
     if (!SWIG_IsOK(res1)) {
-      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vector_integer_t" "', argument " "1"" of type '" "std::vector< int > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vector_integer_T" "', argument " "1"" of type '" "std::vector< int > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_integer_t" "', argument " "1"" of type '" "std::vector< int > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_integer_T" "', argument " "1"" of type '" "std::vector< int > const &""'"); 
     }
     arg1 = ptr;
   }
@@ -12658,7 +12658,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_empty(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_empty(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -12671,7 +12671,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_empty(PyObject *self, PyObject *args
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_empty" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_empty" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = (bool)((std::vector< int > const *)arg1)->empty();
@@ -12682,7 +12682,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_size(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_size(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -12695,7 +12695,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_size(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_size" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_size" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = ((std::vector< int > const *)arg1)->size();
@@ -12706,7 +12706,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_swap(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_swap(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int > *arg2 = 0 ;
@@ -12717,18 +12717,18 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_swap(PyObject *self, PyObject *args)
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_integer_t_swap", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_integer_T_swap", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_swap" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_swap" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], &argp2, SWIGTYPE_p_std__vectorT_int_t,  0 );
   if (!SWIG_IsOK(res2)) {
-    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_integer_t_swap" "', argument " "2"" of type '" "std::vector< int > &""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_integer_T_swap" "', argument " "2"" of type '" "std::vector< int > &""'"); 
   }
   if (!argp2) {
-    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_integer_t_swap" "', argument " "2"" of type '" "std::vector< int > &""'"); 
+    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_integer_T_swap" "', argument " "2"" of type '" "std::vector< int > &""'"); 
   }
   arg2 = reinterpret_cast< std::vector< int > * >(argp2);
   (arg1)->swap(*arg2);
@@ -12739,7 +12739,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_begin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_begin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -12752,7 +12752,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_begin(PyObject *self, PyObject *args
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_begin" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_begin" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = (arg1)->begin();
@@ -12764,7 +12764,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_end(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_end(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -12777,7 +12777,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_end(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_end" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_end" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = (arg1)->end();
@@ -12789,7 +12789,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_rbegin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_rbegin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -12802,7 +12802,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_rbegin(PyObject *self, PyObject *arg
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_rbegin" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_rbegin" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = (arg1)->rbegin();
@@ -12814,7 +12814,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_rend(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_rend(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -12827,7 +12827,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_rend(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_rend" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_rend" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = (arg1)->rend();
@@ -12839,7 +12839,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_clear(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_clear(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -12851,7 +12851,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_clear(PyObject *self, PyObject *args
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_clear" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_clear" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   (arg1)->clear();
@@ -12862,7 +12862,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_get_allocator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_get_allocator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -12875,7 +12875,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_get_allocator(PyObject *self, PyObje
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_get_allocator" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_get_allocator" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = ((std::vector< int > const *)arg1)->get_allocator();
@@ -12886,7 +12886,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_integer_t__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_integer_T__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int >::size_type arg1 ;
   size_t val1 ;
@@ -12897,7 +12897,7 @@ SWIGINTERN PyObject *_wrap_new_vector_integer_t__SWIG_2(PyObject *self, Py_ssize
   if ((nobjs < 1) || (nobjs > 1)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_integer_t" "', argument " "1"" of type '" "std::vector< int >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_integer_T" "', argument " "1"" of type '" "std::vector< int >::size_type""'");
   } 
   arg1 = static_cast< std::vector< int >::size_type >(val1);
   result = (std::vector< int > *)new std::vector< int >(arg1);
@@ -12908,7 +12908,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_pop_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_pop_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -12920,7 +12920,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_pop_back(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_pop_back" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_pop_back" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   (arg1)->pop_back();
@@ -12931,7 +12931,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::size_type arg2 ;
@@ -12944,12 +12944,12 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_resize__SWIG_0(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_resize" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_resize" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t_resize" "', argument " "2"" of type '" "std::vector< int >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T_resize" "', argument " "2"" of type '" "std::vector< int >::size_type""'");
   } 
   arg2 = static_cast< std::vector< int >::size_type >(val2);
   (arg1)->resize(arg2);
@@ -12960,7 +12960,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::iterator arg2 ;
@@ -12974,18 +12974,18 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_erase__SWIG_0(PyObject *self, Py_ssi
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_erase" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_erase" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t_erase" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T_erase" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< int >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< int >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t_erase" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T_erase" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
     }
   }
   result = std_vector_Sl_int_Sg__erase__SWIG_0(arg1,SWIG_STD_MOVE(arg2));
@@ -12997,7 +12997,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::iterator arg2 ;
@@ -13014,29 +13014,29 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_erase__SWIG_1(PyObject *self, Py_ssi
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_erase" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_erase" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t_erase" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T_erase" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< int >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< int >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t_erase" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T_erase" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
     }
   }
   res3 = SWIG_ConvertPtr(swig_obj[2], SWIG_as_voidptrptr(&iter3), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res3) || !iter3) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t_erase" "', argument " "3"" of type '" "std::vector< int >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T_erase" "', argument " "3"" of type '" "std::vector< int >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< int >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< int >::iterator > *>(iter3);
     if (iter_t) {
       arg3 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t_erase" "', argument " "3"" of type '" "std::vector< int >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T_erase" "', argument " "3"" of type '" "std::vector< int >::iterator""'");
     }
   }
   result = std_vector_Sl_int_Sg__erase__SWIG_1(arg1,SWIG_STD_MOVE(arg2),SWIG_STD_MOVE(arg3));
@@ -13048,13 +13048,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_erase(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_erase(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_t_erase", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_T_erase", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -13065,7 +13065,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_erase(PyObject *self, PyObject *args
       int res = SWIG_ConvertPtr(argv[1], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
       _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< int >::iterator > *>(iter) != 0));
       if (_v) {
-        return _wrap_vector_integer_t_erase__SWIG_0(self, argc, argv);
+        return _wrap_vector_integer_T_erase__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -13082,14 +13082,14 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_erase(PyObject *self, PyObject *args
         int res = SWIG_ConvertPtr(argv[2], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
         _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< int >::iterator > *>(iter) != 0));
         if (_v) {
-          return _wrap_vector_integer_t_erase__SWIG_1(self, argc, argv);
+          return _wrap_vector_integer_T_erase__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_t_erase'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_T_erase'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< int >::erase(std::vector< int >::iterator)\n"
     "    std::vector< int >::erase(std::vector< int >::iterator,std::vector< int >::iterator)\n");
@@ -13097,7 +13097,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_integer_t__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_integer_T__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int >::size_type arg1 ;
   std::vector< int >::value_type *arg2 = 0 ;
@@ -13112,12 +13112,12 @@ SWIGINTERN PyObject *_wrap_new_vector_integer_t__SWIG_3(PyObject *self, Py_ssize
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_integer_t" "', argument " "1"" of type '" "std::vector< int >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_integer_T" "', argument " "1"" of type '" "std::vector< int >::size_type""'");
   } 
   arg1 = static_cast< std::vector< int >::size_type >(val1);
   ecode2 = SWIG_AsVal_int(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "new_vector_integer_t" "', argument " "2"" of type '" "std::vector< int >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "new_vector_integer_T" "', argument " "2"" of type '" "std::vector< int >::value_type""'");
   } 
   temp2 = static_cast< std::vector< int >::value_type >(val2);
   arg2 = &temp2;
@@ -13129,16 +13129,16 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_integer_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_new_vector_integer_T(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vector_integer_t", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vector_integer_T", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 0) {
-    return _wrap_new_vector_integer_t__SWIG_0(self, argc, argv);
+    return _wrap_new_vector_integer_T__SWIG_0(self, argc, argv);
   }
   if (argc == 1) {
     int _v = 0;
@@ -13147,7 +13147,7 @@ SWIGINTERN PyObject *_wrap_new_vector_integer_t(PyObject *self, PyObject *args)
       _v = SWIG_CheckState(res);
     }
     if (_v) {
-      return _wrap_new_vector_integer_t__SWIG_2(self, argc, argv);
+      return _wrap_new_vector_integer_T__SWIG_2(self, argc, argv);
     }
   }
   if (argc == 1) {
@@ -13155,7 +13155,7 @@ SWIGINTERN PyObject *_wrap_new_vector_integer_t(PyObject *self, PyObject *args)
     int res = swig::asptr(argv[0], (std::vector< int,std::allocator< int > >**)(0));
     _v = SWIG_CheckState(res);
     if (_v) {
-      return _wrap_new_vector_integer_t__SWIG_1(self, argc, argv);
+      return _wrap_new_vector_integer_T__SWIG_1(self, argc, argv);
     }
   }
   if (argc == 2) {
@@ -13170,13 +13170,13 @@ SWIGINTERN PyObject *_wrap_new_vector_integer_t(PyObject *self, PyObject *args)
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_new_vector_integer_t__SWIG_3(self, argc, argv);
+        return _wrap_new_vector_integer_T__SWIG_3(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vector_integer_t'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vector_integer_T'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< int >::vector()\n"
     "    std::vector< int >::vector(std::vector< int > const &)\n"
@@ -13186,7 +13186,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_push_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_push_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::value_type *arg2 = 0 ;
@@ -13198,15 +13198,15 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_push_back(PyObject *self, PyObject *
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_integer_t_push_back", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_integer_T_push_back", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_push_back" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_push_back" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_int(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t_push_back" "', argument " "2"" of type '" "std::vector< int >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T_push_back" "', argument " "2"" of type '" "std::vector< int >::value_type""'");
   } 
   temp2 = static_cast< std::vector< int >::value_type >(val2);
   arg2 = &temp2;
@@ -13218,7 +13218,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_front(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_front(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -13231,7 +13231,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_front(PyObject *self, PyObject *args
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_front" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_front" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = (std::vector< int >::value_type *) &((std::vector< int > const *)arg1)->front();
@@ -13243,7 +13243,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -13256,7 +13256,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_back(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_back" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_back" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = (std::vector< int >::value_type *) &((std::vector< int > const *)arg1)->back();
@@ -13268,7 +13268,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_assign(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_assign(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::size_type arg2 ;
@@ -13283,20 +13283,20 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_assign(PyObject *self, PyObject *arg
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_integer_t_assign", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_integer_T_assign", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_assign" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_assign" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t_assign" "', argument " "2"" of type '" "std::vector< int >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T_assign" "', argument " "2"" of type '" "std::vector< int >::size_type""'");
   } 
   arg2 = static_cast< std::vector< int >::size_type >(val2);
   ecode3 = SWIG_AsVal_int(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_t_assign" "', argument " "3"" of type '" "std::vector< int >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_T_assign" "', argument " "3"" of type '" "std::vector< int >::value_type""'");
   } 
   temp3 = static_cast< std::vector< int >::value_type >(val3);
   arg3 = &temp3;
@@ -13308,7 +13308,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::size_type arg2 ;
@@ -13325,17 +13325,17 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_resize__SWIG_1(PyObject *self, Py_ss
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_resize" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_resize" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t_resize" "', argument " "2"" of type '" "std::vector< int >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T_resize" "', argument " "2"" of type '" "std::vector< int >::size_type""'");
   } 
   arg2 = static_cast< std::vector< int >::size_type >(val2);
   ecode3 = SWIG_AsVal_int(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_t_resize" "', argument " "3"" of type '" "std::vector< int >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_T_resize" "', argument " "3"" of type '" "std::vector< int >::value_type""'");
   } 
   temp3 = static_cast< std::vector< int >::value_type >(val3);
   arg3 = &temp3;
@@ -13347,13 +13347,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_resize(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_resize(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_t_resize", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_T_resize", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -13365,7 +13365,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_resize(PyObject *self, PyObject *arg
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_integer_t_resize__SWIG_0(self, argc, argv);
+        return _wrap_vector_integer_T_resize__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -13384,14 +13384,14 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_resize(PyObject *self, PyObject *arg
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_integer_t_resize__SWIG_1(self, argc, argv);
+          return _wrap_vector_integer_T_resize__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_t_resize'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_T_resize'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< int >::resize(std::vector< int >::size_type)\n"
     "    std::vector< int >::resize(std::vector< int >::size_type,std::vector< int >::value_type const &)\n");
@@ -13399,7 +13399,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::iterator arg2 ;
@@ -13417,23 +13417,23 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_insert__SWIG_0(PyObject *self, Py_ss
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_insert" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_insert" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t_insert" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T_insert" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< int >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< int >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t_insert" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T_insert" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_int(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_t_insert" "', argument " "3"" of type '" "std::vector< int >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_T_insert" "', argument " "3"" of type '" "std::vector< int >::value_type""'");
   } 
   temp3 = static_cast< std::vector< int >::value_type >(val3);
   arg3 = &temp3;
@@ -13446,7 +13446,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::iterator arg2 ;
@@ -13466,28 +13466,28 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_insert__SWIG_1(PyObject *self, Py_ss
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_insert" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_insert" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t_insert" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T_insert" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< int >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< int >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t_insert" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T_insert" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_size_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_t_insert" "', argument " "3"" of type '" "std::vector< int >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_T_insert" "', argument " "3"" of type '" "std::vector< int >::size_type""'");
   } 
   arg3 = static_cast< std::vector< int >::size_type >(val3);
   ecode4 = SWIG_AsVal_int(swig_obj[3], &val4);
   if (!SWIG_IsOK(ecode4)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode4), "in method '" "vector_integer_t_insert" "', argument " "4"" of type '" "std::vector< int >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode4), "in method '" "vector_integer_T_insert" "', argument " "4"" of type '" "std::vector< int >::value_type""'");
   } 
   temp4 = static_cast< std::vector< int >::value_type >(val4);
   arg4 = &temp4;
@@ -13499,13 +13499,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_insert(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_insert(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_t_insert", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_T_insert", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -13521,7 +13521,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_insert(PyObject *self, PyObject *arg
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_integer_t_insert__SWIG_0(self, argc, argv);
+          return _wrap_vector_integer_T_insert__SWIG_0(self, argc, argv);
         }
       }
     }
@@ -13545,7 +13545,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_insert(PyObject *self, PyObject *arg
             _v = SWIG_CheckState(res);
           }
           if (_v) {
-            return _wrap_vector_integer_t_insert__SWIG_1(self, argc, argv);
+            return _wrap_vector_integer_T_insert__SWIG_1(self, argc, argv);
           }
         }
       }
@@ -13553,7 +13553,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_insert(PyObject *self, PyObject *arg
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_t_insert'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_T_insert'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< int >::insert(std::vector< int >::iterator,std::vector< int >::value_type const &)\n"
     "    std::vector< int >::insert(std::vector< int >::iterator,std::vector< int >::size_type,std::vector< int >::value_type const &)\n");
@@ -13561,7 +13561,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_reserve(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_reserve(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::size_type arg2 ;
@@ -13572,15 +13572,15 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_reserve(PyObject *self, PyObject *ar
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_integer_t_reserve", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_integer_T_reserve", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_reserve" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_reserve" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t_reserve" "', argument " "2"" of type '" "std::vector< int >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T_reserve" "', argument " "2"" of type '" "std::vector< int >::size_type""'");
   } 
   arg2 = static_cast< std::vector< int >::size_type >(val2);
   (arg1)->reserve(arg2);
@@ -13591,7 +13591,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_capacity(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_capacity(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -13604,7 +13604,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_capacity(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_capacity" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_capacity" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = ((std::vector< int > const *)arg1)->capacity();
@@ -13615,7 +13615,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_delete_vector_integer_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_delete_vector_integer_T(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -13627,7 +13627,7 @@ SWIGINTERN PyObject *_wrap_delete_vector_integer_t(PyObject *self, PyObject *arg
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, SWIG_POINTER_DISOWN |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vector_integer_t" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vector_integer_T" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   {
@@ -13648,18 +13648,18 @@ fail:
 }
 
 
-SWIGINTERN PyObject *vector_integer_t_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vector_integer_T_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   PyObject *obj;
   if (!SWIG_Python_UnpackTuple(args, "swigregister", 1, 1, &obj)) return NULL;
   SWIG_TypeNewClientData(SWIGTYPE_p_std__vectorT_int_t, SWIG_NewClientData(obj));
   return SWIG_Py_Void();
 }
 
-SWIGINTERN PyObject *vector_integer_t_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vector_integer_T_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   return SWIG_Python_InitShadowInstance(args);
 }
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_iterator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_iterator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   PyObject **arg2 = (PyObject **) 0 ;
@@ -13674,7 +13674,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_iterator(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_iterator" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_iterator" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = (swig::SwigPyIterator *)std_vector_Sl_std_vector_Sl_int_Sg__Sg__iterator(arg1,arg2);
@@ -13685,7 +13685,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___nonzero__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___nonzero__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -13698,7 +13698,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___nonzero__(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___nonzero__" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___nonzero__" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = (bool)std_vector_Sl_std_vector_Sl_int_Sg__Sg____nonzero__((std::vector< std::vector< int > > const *)arg1);
@@ -13709,7 +13709,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___bool__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___bool__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -13722,7 +13722,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___bool__(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___bool__" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___bool__" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = (bool)std_vector_Sl_std_vector_Sl_int_Sg__Sg____bool__((std::vector< std::vector< int > > const *)arg1);
@@ -13733,7 +13733,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___len__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___len__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -13746,7 +13746,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___len__(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___len__" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___len__" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = std_vector_Sl_std_vector_Sl_int_Sg__Sg____len__((std::vector< std::vector< int > > const *)arg1);
@@ -13757,7 +13757,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___getslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___getslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::difference_type arg2 ;
@@ -13772,20 +13772,20 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___getslice__(PyObject *self, PyObject *a
   std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > *result = 0 ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_t___getslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_T___getslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___getslice__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___getslice__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_t___getslice__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_T___getslice__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< int > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vinteger2d_t___getslice__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vinteger2d_T___getslice__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::vector< int > >::difference_type >(val3);
   try {
@@ -13802,7 +13802,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::difference_type arg2 ;
@@ -13818,17 +13818,17 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setslice____SWIG_0(PyObject *self, Py_
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___setslice__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___setslice__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_t___setslice__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_T___setslice__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< int > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vinteger2d_t___setslice__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vinteger2d_T___setslice__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::vector< int > >::difference_type >(val3);
   try {
@@ -13845,7 +13845,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::difference_type arg2 ;
@@ -13863,27 +13863,27 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setslice____SWIG_1(PyObject *self, Py_
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___setslice__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___setslice__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_t___setslice__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_T___setslice__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< int > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vinteger2d_t___setslice__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vinteger2d_T___setslice__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::vector< int > >::difference_type >(val3);
   {
     std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > *ptr = (std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > *)0;
     res4 = swig::asptr(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vinteger2d_t___setslice__" "', argument " "4"" of type '" "std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vinteger2d_T___setslice__" "', argument " "4"" of type '" "std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_t___setslice__" "', argument " "4"" of type '" "std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_T___setslice__" "', argument " "4"" of type '" "std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > const &""'"); 
     }
     arg4 = ptr;
   }
@@ -13903,13 +13903,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___setslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___setslice__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_t___setslice__", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_T___setslice__", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -13926,7 +13926,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setslice__(PyObject *self, PyObject *a
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vinteger2d_t___setslice____SWIG_0(self, argc, argv);
+          return _wrap_vinteger2d_T___setslice____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -13949,7 +13949,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setslice__(PyObject *self, PyObject *a
           int res = swig::asptr(argv[3], (std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > >**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vinteger2d_t___setslice____SWIG_1(self, argc, argv);
+            return _wrap_vinteger2d_T___setslice____SWIG_1(self, argc, argv);
           }
         }
       }
@@ -13957,7 +13957,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setslice__(PyObject *self, PyObject *a
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_t___setslice__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_T___setslice__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< int > >::__setslice__(std::vector< std::vector< int > >::difference_type,std::vector< std::vector< int > >::difference_type)\n"
     "    std::vector< std::vector< int > >::__setslice__(std::vector< std::vector< int > >::difference_type,std::vector< std::vector< int > >::difference_type,std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > const &)\n");
@@ -13965,7 +13965,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___delslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___delslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::difference_type arg2 ;
@@ -13979,20 +13979,20 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___delslice__(PyObject *self, PyObject *a
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_t___delslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_T___delslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___delslice__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___delslice__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_t___delslice__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_T___delslice__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< int > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vinteger2d_t___delslice__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vinteger2d_T___delslice__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::vector< int > >::difference_type >(val3);
   try {
@@ -14009,7 +14009,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::difference_type arg2 ;
@@ -14022,12 +14022,12 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___delitem____SWIG_0(PyObject *self, Py_s
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___delitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___delitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_t___delitem__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_T___delitem__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< int > >::difference_type >(val2);
   try {
@@ -14044,7 +14044,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -14056,12 +14056,12 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___getitem____SWIG_0(PyObject *self, Py_s
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___getitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___getitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -14079,7 +14079,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -14092,12 +14092,12 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setitem____SWIG_0(PyObject *self, Py_s
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -14105,10 +14105,10 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setitem____SWIG_0(PyObject *self, Py_s
     std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > *ptr = (std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vinteger2d_t___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vinteger2d_T___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_t___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_T___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > const &""'"); 
     }
     arg3 = ptr;
   }
@@ -14128,7 +14128,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -14139,12 +14139,12 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setitem____SWIG_1(PyObject *self, Py_s
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -14162,7 +14162,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -14173,12 +14173,12 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___delitem____SWIG_1(PyObject *self, Py_s
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___delitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___delitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -14196,13 +14196,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___delitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___delitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_t___delitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_T___delitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -14213,7 +14213,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___delitem__(PyObject *self, PyObject *ar
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vinteger2d_t___delitem____SWIG_1(self, argc, argv);
+        return _wrap_vinteger2d_T___delitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -14227,13 +14227,13 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___delitem__(PyObject *self, PyObject *ar
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vinteger2d_t___delitem____SWIG_0(self, argc, argv);
+        return _wrap_vinteger2d_T___delitem____SWIG_0(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_t___delitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_T___delitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< int > >::__delitem__(std::vector< std::vector< int > >::difference_type)\n"
     "    std::vector< std::vector< int > >::__delitem__(SWIGPY_SLICEOBJECT *)\n");
@@ -14241,7 +14241,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::difference_type arg2 ;
@@ -14255,12 +14255,12 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___getitem____SWIG_1(PyObject *self, Py_s
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___getitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___getitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_t___getitem__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_T___getitem__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< int > >::difference_type >(val2);
   try {
@@ -14276,13 +14276,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___getitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___getitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_t___getitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_T___getitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -14293,7 +14293,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___getitem__(PyObject *self, PyObject *ar
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vinteger2d_t___getitem____SWIG_0(self, argc, argv);
+        return _wrap_vinteger2d_T___getitem____SWIG_0(self, argc, argv);
       }
     }
   }
@@ -14307,13 +14307,13 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___getitem__(PyObject *self, PyObject *ar
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vinteger2d_t___getitem____SWIG_1(self, argc, argv);
+        return _wrap_vinteger2d_T___getitem____SWIG_1(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_t___getitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_T___getitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< int > >::__getitem__(SWIGPY_SLICEOBJECT *)\n"
     "    std::vector< std::vector< int > >::__getitem__(std::vector< std::vector< int > >::difference_type) const\n");
@@ -14321,7 +14321,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::difference_type arg2 ;
@@ -14336,22 +14336,22 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setitem____SWIG_2(PyObject *self, Py_s
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_t___setitem__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_T___setitem__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< int > >::difference_type >(val2);
   {
     std::vector< int,std::allocator< int > > *ptr = (std::vector< int,std::allocator< int > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vinteger2d_t___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vinteger2d_T___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_t___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_T___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -14369,13 +14369,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___setitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___setitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_t___setitem__", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_T___setitem__", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -14386,7 +14386,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setitem__(PyObject *self, PyObject *ar
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vinteger2d_t___setitem____SWIG_1(self, argc, argv);
+        return _wrap_vinteger2d_T___setitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -14402,7 +14402,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setitem__(PyObject *self, PyObject *ar
         int res = swig::asptr(argv[2], (std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vinteger2d_t___setitem____SWIG_0(self, argc, argv);
+          return _wrap_vinteger2d_T___setitem____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -14420,14 +14420,14 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setitem__(PyObject *self, PyObject *ar
         int res = swig::asptr(argv[2], (std::vector< int,std::allocator< int > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vinteger2d_t___setitem____SWIG_2(self, argc, argv);
+          return _wrap_vinteger2d_T___setitem____SWIG_2(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_t___setitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_T___setitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< int > >::__setitem__(SWIGPY_SLICEOBJECT *,std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > const &)\n"
     "    std::vector< std::vector< int > >::__setitem__(SWIGPY_SLICEOBJECT *)\n"
@@ -14436,7 +14436,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_pop(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_pop(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -14449,7 +14449,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_pop(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_pop" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_pop" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   try {
@@ -14464,7 +14464,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_append(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_append(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::value_type *arg2 = 0 ;
@@ -14474,20 +14474,20 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_append(PyObject *self, PyObject *args) {
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_t_append", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_T_append", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_append" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_append" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   {
     std::vector< int,std::allocator< int > > *ptr = (std::vector< int,std::allocator< int > > *)0;
     res2 = swig::asptr(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vinteger2d_t_append" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vinteger2d_T_append" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_t_append" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_T_append" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -14501,7 +14501,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vinteger2d_t__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
+SWIGINTERN PyObject *_wrap_new_vinteger2d_T__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *result = 0 ;
   
@@ -14515,7 +14515,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vinteger2d_t__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vinteger2d_T__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int,std::allocator< int > > > *arg1 = 0 ;
   int res1 = SWIG_OLDOBJ ;
@@ -14527,10 +14527,10 @@ SWIGINTERN PyObject *_wrap_new_vinteger2d_t__SWIG_1(PyObject *self, Py_ssize_t n
     std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > *ptr = (std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > *)0;
     res1 = swig::asptr(swig_obj[0], &ptr);
     if (!SWIG_IsOK(res1)) {
-      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vinteger2d_t" "', argument " "1"" of type '" "std::vector< std::vector< int,std::allocator< int > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vinteger2d_T" "', argument " "1"" of type '" "std::vector< std::vector< int,std::allocator< int > > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vinteger2d_t" "', argument " "1"" of type '" "std::vector< std::vector< int,std::allocator< int > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vinteger2d_T" "', argument " "1"" of type '" "std::vector< std::vector< int,std::allocator< int > > > const &""'"); 
     }
     arg1 = ptr;
   }
@@ -14544,7 +14544,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_empty(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_empty(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -14557,7 +14557,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_empty(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_empty" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_empty" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = (bool)((std::vector< std::vector< int > > const *)arg1)->empty();
@@ -14568,7 +14568,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_size(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_size(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -14581,7 +14581,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_size(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_size" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_size" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = ((std::vector< std::vector< int > > const *)arg1)->size();
@@ -14592,7 +14592,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_swap(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_swap(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int,std::allocator< int > > > *arg2 = 0 ;
@@ -14603,18 +14603,18 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_swap(PyObject *self, PyObject *args) {
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_t_swap", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_T_swap", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_swap" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_swap" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], &argp2, SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t,  0 );
   if (!SWIG_IsOK(res2)) {
-    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vinteger2d_t_swap" "', argument " "2"" of type '" "std::vector< std::vector< int,std::allocator< int > > > &""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vinteger2d_T_swap" "', argument " "2"" of type '" "std::vector< std::vector< int,std::allocator< int > > > &""'"); 
   }
   if (!argp2) {
-    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_t_swap" "', argument " "2"" of type '" "std::vector< std::vector< int,std::allocator< int > > > &""'"); 
+    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_T_swap" "', argument " "2"" of type '" "std::vector< std::vector< int,std::allocator< int > > > &""'"); 
   }
   arg2 = reinterpret_cast< std::vector< std::vector< int,std::allocator< int > > > * >(argp2);
   (arg1)->swap(*arg2);
@@ -14625,7 +14625,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_begin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_begin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -14638,7 +14638,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_begin(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_begin" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_begin" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = (arg1)->begin();
@@ -14650,7 +14650,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_end(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_end(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -14663,7 +14663,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_end(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_end" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_end" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = (arg1)->end();
@@ -14675,7 +14675,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_rbegin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_rbegin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -14688,7 +14688,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_rbegin(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_rbegin" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_rbegin" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = (arg1)->rbegin();
@@ -14700,7 +14700,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_rend(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_rend(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -14713,7 +14713,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_rend(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_rend" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_rend" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = (arg1)->rend();
@@ -14725,7 +14725,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_clear(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_clear(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -14737,7 +14737,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_clear(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_clear" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_clear" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   (arg1)->clear();
@@ -14748,7 +14748,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_get_allocator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_get_allocator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -14761,7 +14761,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_get_allocator(PyObject *self, PyObject *
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_get_allocator" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_get_allocator" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = ((std::vector< std::vector< int > > const *)arg1)->get_allocator();
@@ -14772,7 +14772,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vinteger2d_t__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vinteger2d_T__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > >::size_type arg1 ;
   size_t val1 ;
@@ -14783,7 +14783,7 @@ SWIGINTERN PyObject *_wrap_new_vinteger2d_t__SWIG_2(PyObject *self, Py_ssize_t n
   if ((nobjs < 1) || (nobjs > 1)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vinteger2d_t" "', argument " "1"" of type '" "std::vector< std::vector< int > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vinteger2d_T" "', argument " "1"" of type '" "std::vector< std::vector< int > >::size_type""'");
   } 
   arg1 = static_cast< std::vector< std::vector< int > >::size_type >(val1);
   result = (std::vector< std::vector< int > > *)new std::vector< std::vector< int > >(arg1);
@@ -14794,7 +14794,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_pop_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_pop_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -14806,7 +14806,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_pop_back(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_pop_back" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_pop_back" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   (arg1)->pop_back();
@@ -14817,7 +14817,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::size_type arg2 ;
@@ -14830,12 +14830,12 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_resize__SWIG_0(PyObject *self, Py_ssize_
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_resize" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_resize" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_t_resize" "', argument " "2"" of type '" "std::vector< std::vector< int > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_T_resize" "', argument " "2"" of type '" "std::vector< std::vector< int > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< int > >::size_type >(val2);
   (arg1)->resize(arg2);
@@ -14846,7 +14846,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::iterator arg2 ;
@@ -14860,18 +14860,18 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_erase__SWIG_0(PyObject *self, Py_ssize_t
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_erase" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_erase" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t_erase" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T_erase" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t_erase" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T_erase" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
     }
   }
   result = std_vector_Sl_std_vector_Sl_int_Sg__Sg__erase__SWIG_0(arg1,SWIG_STD_MOVE(arg2));
@@ -14883,7 +14883,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::iterator arg2 ;
@@ -14900,29 +14900,29 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_erase__SWIG_1(PyObject *self, Py_ssize_t
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_erase" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_erase" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t_erase" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T_erase" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t_erase" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T_erase" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
     }
   }
   res3 = SWIG_ConvertPtr(swig_obj[2], SWIG_as_voidptrptr(&iter3), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res3) || !iter3) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t_erase" "', argument " "3"" of type '" "std::vector< std::vector< int > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T_erase" "', argument " "3"" of type '" "std::vector< std::vector< int > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *>(iter3);
     if (iter_t) {
       arg3 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t_erase" "', argument " "3"" of type '" "std::vector< std::vector< int > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T_erase" "', argument " "3"" of type '" "std::vector< std::vector< int > >::iterator""'");
     }
   }
   result = std_vector_Sl_std_vector_Sl_int_Sg__Sg__erase__SWIG_1(arg1,SWIG_STD_MOVE(arg2),SWIG_STD_MOVE(arg3));
@@ -14934,13 +14934,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_erase(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_erase(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_t_erase", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_T_erase", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -14951,7 +14951,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_erase(PyObject *self, PyObject *args) {
       int res = SWIG_ConvertPtr(argv[1], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
       _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *>(iter) != 0));
       if (_v) {
-        return _wrap_vinteger2d_t_erase__SWIG_0(self, argc, argv);
+        return _wrap_vinteger2d_T_erase__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -14968,14 +14968,14 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_erase(PyObject *self, PyObject *args) {
         int res = SWIG_ConvertPtr(argv[2], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
         _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *>(iter) != 0));
         if (_v) {
-          return _wrap_vinteger2d_t_erase__SWIG_1(self, argc, argv);
+          return _wrap_vinteger2d_T_erase__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_t_erase'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_T_erase'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< int > >::erase(std::vector< std::vector< int > >::iterator)\n"
     "    std::vector< std::vector< int > >::erase(std::vector< std::vector< int > >::iterator,std::vector< std::vector< int > >::iterator)\n");
@@ -14983,7 +14983,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vinteger2d_t__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vinteger2d_T__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > >::size_type arg1 ;
   std::vector< std::vector< int > >::value_type *arg2 = 0 ;
@@ -14996,17 +14996,17 @@ SWIGINTERN PyObject *_wrap_new_vinteger2d_t__SWIG_3(PyObject *self, Py_ssize_t n
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vinteger2d_t" "', argument " "1"" of type '" "std::vector< std::vector< int > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vinteger2d_T" "', argument " "1"" of type '" "std::vector< std::vector< int > >::size_type""'");
   } 
   arg1 = static_cast< std::vector< std::vector< int > >::size_type >(val1);
   {
     std::vector< int,std::allocator< int > > *ptr = (std::vector< int,std::allocator< int > > *)0;
     res2 = swig::asptr(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "new_vinteger2d_t" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "new_vinteger2d_T" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vinteger2d_t" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vinteger2d_T" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -15020,16 +15020,16 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vinteger2d_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_new_vinteger2d_T(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vinteger2d_t", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vinteger2d_T", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 0) {
-    return _wrap_new_vinteger2d_t__SWIG_0(self, argc, argv);
+    return _wrap_new_vinteger2d_T__SWIG_0(self, argc, argv);
   }
   if (argc == 1) {
     int _v = 0;
@@ -15038,7 +15038,7 @@ SWIGINTERN PyObject *_wrap_new_vinteger2d_t(PyObject *self, PyObject *args) {
       _v = SWIG_CheckState(res);
     }
     if (_v) {
-      return _wrap_new_vinteger2d_t__SWIG_2(self, argc, argv);
+      return _wrap_new_vinteger2d_T__SWIG_2(self, argc, argv);
     }
   }
   if (argc == 1) {
@@ -15046,7 +15046,7 @@ SWIGINTERN PyObject *_wrap_new_vinteger2d_t(PyObject *self, PyObject *args) {
     int res = swig::asptr(argv[0], (std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > >**)(0));
     _v = SWIG_CheckState(res);
     if (_v) {
-      return _wrap_new_vinteger2d_t__SWIG_1(self, argc, argv);
+      return _wrap_new_vinteger2d_T__SWIG_1(self, argc, argv);
     }
   }
   if (argc == 2) {
@@ -15059,13 +15059,13 @@ SWIGINTERN PyObject *_wrap_new_vinteger2d_t(PyObject *self, PyObject *args) {
       int res = swig::asptr(argv[1], (std::vector< int,std::allocator< int > >**)(0));
       _v = SWIG_CheckState(res);
       if (_v) {
-        return _wrap_new_vinteger2d_t__SWIG_3(self, argc, argv);
+        return _wrap_new_vinteger2d_T__SWIG_3(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vinteger2d_t'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vinteger2d_T'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< int > >::vector()\n"
     "    std::vector< std::vector< int > >::vector(std::vector< std::vector< int,std::allocator< int > > > const &)\n"
@@ -15075,7 +15075,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_push_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_push_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::value_type *arg2 = 0 ;
@@ -15085,20 +15085,20 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_push_back(PyObject *self, PyObject *args
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_t_push_back", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_T_push_back", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_push_back" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_push_back" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   {
     std::vector< int,std::allocator< int > > *ptr = (std::vector< int,std::allocator< int > > *)0;
     res2 = swig::asptr(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vinteger2d_t_push_back" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vinteger2d_T_push_back" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_t_push_back" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_T_push_back" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -15112,7 +15112,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_front(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_front(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -15125,7 +15125,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_front(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_front" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_front" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = (std::vector< std::vector< int > >::value_type *) &((std::vector< std::vector< int > > const *)arg1)->front();
@@ -15137,7 +15137,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -15150,7 +15150,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_back(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_back" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_back" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = (std::vector< std::vector< int > >::value_type *) &((std::vector< std::vector< int > > const *)arg1)->back();
@@ -15162,7 +15162,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_assign(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_assign(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::size_type arg2 ;
@@ -15175,25 +15175,25 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_assign(PyObject *self, PyObject *args) {
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_t_assign", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_T_assign", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_assign" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_assign" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_t_assign" "', argument " "2"" of type '" "std::vector< std::vector< int > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_T_assign" "', argument " "2"" of type '" "std::vector< std::vector< int > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< int > >::size_type >(val2);
   {
     std::vector< int,std::allocator< int > > *ptr = (std::vector< int,std::allocator< int > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vinteger2d_t_assign" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vinteger2d_T_assign" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_t_assign" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_T_assign" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -15207,7 +15207,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::size_type arg2 ;
@@ -15222,22 +15222,22 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_resize__SWIG_1(PyObject *self, Py_ssize_
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_resize" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_resize" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_t_resize" "', argument " "2"" of type '" "std::vector< std::vector< int > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_T_resize" "', argument " "2"" of type '" "std::vector< std::vector< int > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< int > >::size_type >(val2);
   {
     std::vector< int,std::allocator< int > > *ptr = (std::vector< int,std::allocator< int > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vinteger2d_t_resize" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vinteger2d_T_resize" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_t_resize" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_T_resize" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -15251,13 +15251,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_resize(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_resize(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_t_resize", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_T_resize", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -15269,7 +15269,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_resize(PyObject *self, PyObject *args) {
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vinteger2d_t_resize__SWIG_0(self, argc, argv);
+        return _wrap_vinteger2d_T_resize__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -15286,14 +15286,14 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_resize(PyObject *self, PyObject *args) {
         int res = swig::asptr(argv[2], (std::vector< int,std::allocator< int > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vinteger2d_t_resize__SWIG_1(self, argc, argv);
+          return _wrap_vinteger2d_T_resize__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_t_resize'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_T_resize'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< int > >::resize(std::vector< std::vector< int > >::size_type)\n"
     "    std::vector< std::vector< int > >::resize(std::vector< std::vector< int > >::size_type,std::vector< std::vector< int > >::value_type const &)\n");
@@ -15301,7 +15301,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::iterator arg2 ;
@@ -15317,28 +15317,28 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_insert__SWIG_0(PyObject *self, Py_ssize_
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_insert" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_insert" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t_insert" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T_insert" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t_insert" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T_insert" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
     }
   }
   {
     std::vector< int,std::allocator< int > > *ptr = (std::vector< int,std::allocator< int > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vinteger2d_t_insert" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vinteger2d_T_insert" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_t_insert" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_T_insert" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -15353,7 +15353,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::iterator arg2 ;
@@ -15371,33 +15371,33 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_insert__SWIG_1(PyObject *self, Py_ssize_
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_insert" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_insert" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t_insert" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T_insert" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t_insert" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T_insert" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_size_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vinteger2d_t_insert" "', argument " "3"" of type '" "std::vector< std::vector< int > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vinteger2d_T_insert" "', argument " "3"" of type '" "std::vector< std::vector< int > >::size_type""'");
   } 
   arg3 = static_cast< std::vector< std::vector< int > >::size_type >(val3);
   {
     std::vector< int,std::allocator< int > > *ptr = (std::vector< int,std::allocator< int > > *)0;
     res4 = swig::asptr(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vinteger2d_t_insert" "', argument " "4"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vinteger2d_T_insert" "', argument " "4"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_t_insert" "', argument " "4"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_T_insert" "', argument " "4"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     arg4 = ptr;
   }
@@ -15411,13 +15411,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_insert(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_insert(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_t_insert", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_T_insert", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -15431,7 +15431,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_insert(PyObject *self, PyObject *args) {
         int res = swig::asptr(argv[2], (std::vector< int,std::allocator< int > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vinteger2d_t_insert__SWIG_0(self, argc, argv);
+          return _wrap_vinteger2d_T_insert__SWIG_0(self, argc, argv);
         }
       }
     }
@@ -15453,7 +15453,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_insert(PyObject *self, PyObject *args) {
           int res = swig::asptr(argv[3], (std::vector< int,std::allocator< int > >**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vinteger2d_t_insert__SWIG_1(self, argc, argv);
+            return _wrap_vinteger2d_T_insert__SWIG_1(self, argc, argv);
           }
         }
       }
@@ -15461,7 +15461,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_insert(PyObject *self, PyObject *args) {
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_t_insert'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_T_insert'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< int > >::insert(std::vector< std::vector< int > >::iterator,std::vector< std::vector< int > >::value_type const &)\n"
     "    std::vector< std::vector< int > >::insert(std::vector< std::vector< int > >::iterator,std::vector< std::vector< int > >::size_type,std::vector< std::vector< int > >::value_type const &)\n");
@@ -15469,7 +15469,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_reserve(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_reserve(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::size_type arg2 ;
@@ -15480,15 +15480,15 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_reserve(PyObject *self, PyObject *args)
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_t_reserve", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_T_reserve", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_reserve" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_reserve" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_t_reserve" "', argument " "2"" of type '" "std::vector< std::vector< int > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_T_reserve" "', argument " "2"" of type '" "std::vector< std::vector< int > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< int > >::size_type >(val2);
   (arg1)->reserve(arg2);
@@ -15499,7 +15499,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_capacity(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_capacity(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -15512,7 +15512,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_capacity(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_capacity" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_capacity" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = ((std::vector< std::vector< int > > const *)arg1)->capacity();
@@ -15523,7 +15523,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_delete_vinteger2d_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_delete_vinteger2d_T(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -15535,7 +15535,7 @@ SWIGINTERN PyObject *_wrap_delete_vinteger2d_t(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, SWIG_POINTER_DISOWN |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vinteger2d_t" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vinteger2d_T" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   {
@@ -15556,18 +15556,18 @@ fail:
 }
 
 
-SWIGINTERN PyObject *vinteger2d_t_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vinteger2d_T_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   PyObject *obj;
   if (!SWIG_Python_UnpackTuple(args, "swigregister", 1, 1, &obj)) return NULL;
   SWIG_TypeNewClientData(SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, SWIG_NewClientData(obj));
   return SWIG_Py_Void();
 }
 
-SWIGINTERN PyObject *vinteger2d_t_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vinteger2d_T_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   return SWIG_Python_InitShadowInstance(args);
 }
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_iterator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_iterator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   PyObject **arg2 = (PyObject **) 0 ;
@@ -15582,7 +15582,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_iterator(PyObject *self, PyObjec
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_iterator" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_iterator" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = (swig::SwigPyIterator *)std_vector_Sl_unsigned_SS_long_Sg__iterator(arg1,arg2);
@@ -15593,7 +15593,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___nonzero__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___nonzero__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -15606,7 +15606,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___nonzero__(PyObject *self, PyOb
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___nonzero__" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___nonzero__" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = (bool)std_vector_Sl_unsigned_SS_long_Sg____nonzero__((std::vector< unsigned long > const *)arg1);
@@ -15617,7 +15617,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___bool__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___bool__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -15630,7 +15630,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___bool__(PyObject *self, PyObjec
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___bool__" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___bool__" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = (bool)std_vector_Sl_unsigned_SS_long_Sg____bool__((std::vector< unsigned long > const *)arg1);
@@ -15641,7 +15641,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___len__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___len__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -15654,7 +15654,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___len__(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___len__" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___len__" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = std_vector_Sl_unsigned_SS_long_Sg____len__((std::vector< unsigned long > const *)arg1);
@@ -15665,7 +15665,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___getslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___getslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::difference_type arg2 ;
@@ -15680,20 +15680,20 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___getslice__(PyObject *self, PyO
   std::vector< unsigned long,std::allocator< unsigned long > > *result = 0 ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_t___getslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_T___getslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___getslice__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___getslice__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t___getslice__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T___getslice__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< unsigned long >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_t___getslice__" "', argument " "3"" of type '" "std::vector< unsigned long >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_T___getslice__" "', argument " "3"" of type '" "std::vector< unsigned long >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< unsigned long >::difference_type >(val3);
   try {
@@ -15710,7 +15710,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::difference_type arg2 ;
@@ -15726,17 +15726,17 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setslice____SWIG_0(PyObject *s
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___setslice__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___setslice__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t___setslice__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T___setslice__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< unsigned long >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_t___setslice__" "', argument " "3"" of type '" "std::vector< unsigned long >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_T___setslice__" "', argument " "3"" of type '" "std::vector< unsigned long >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< unsigned long >::difference_type >(val3);
   try {
@@ -15753,7 +15753,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::difference_type arg2 ;
@@ -15771,27 +15771,27 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setslice____SWIG_1(PyObject *s
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___setslice__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___setslice__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t___setslice__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T___setslice__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< unsigned long >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_t___setslice__" "', argument " "3"" of type '" "std::vector< unsigned long >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_T___setslice__" "', argument " "3"" of type '" "std::vector< unsigned long >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< unsigned long >::difference_type >(val3);
   {
     std::vector< unsigned long,std::allocator< unsigned long > > *ptr = (std::vector< unsigned long,std::allocator< unsigned long > > *)0;
     res4 = swig::asptr(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_longinteger_t___setslice__" "', argument " "4"" of type '" "std::vector< unsigned long,std::allocator< unsigned long > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_longinteger_T___setslice__" "', argument " "4"" of type '" "std::vector< unsigned long,std::allocator< unsigned long > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_longinteger_t___setslice__" "', argument " "4"" of type '" "std::vector< unsigned long,std::allocator< unsigned long > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_longinteger_T___setslice__" "', argument " "4"" of type '" "std::vector< unsigned long,std::allocator< unsigned long > > const &""'"); 
     }
     arg4 = ptr;
   }
@@ -15811,13 +15811,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___setslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___setslice__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_t___setslice__", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_T___setslice__", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -15834,7 +15834,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setslice__(PyObject *self, PyO
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_longinteger_t___setslice____SWIG_0(self, argc, argv);
+          return _wrap_vector_longinteger_T___setslice____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -15857,7 +15857,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setslice__(PyObject *self, PyO
           int res = swig::asptr(argv[3], (std::vector< unsigned long,std::allocator< unsigned long > >**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vector_longinteger_t___setslice____SWIG_1(self, argc, argv);
+            return _wrap_vector_longinteger_T___setslice____SWIG_1(self, argc, argv);
           }
         }
       }
@@ -15865,7 +15865,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setslice__(PyObject *self, PyO
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_t___setslice__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_T___setslice__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< unsigned long >::__setslice__(std::vector< unsigned long >::difference_type,std::vector< unsigned long >::difference_type)\n"
     "    std::vector< unsigned long >::__setslice__(std::vector< unsigned long >::difference_type,std::vector< unsigned long >::difference_type,std::vector< unsigned long,std::allocator< unsigned long > > const &)\n");
@@ -15873,7 +15873,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___delslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___delslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::difference_type arg2 ;
@@ -15887,20 +15887,20 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___delslice__(PyObject *self, PyO
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_t___delslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_T___delslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___delslice__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___delslice__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t___delslice__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T___delslice__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< unsigned long >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_t___delslice__" "', argument " "3"" of type '" "std::vector< unsigned long >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_T___delslice__" "', argument " "3"" of type '" "std::vector< unsigned long >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< unsigned long >::difference_type >(val3);
   try {
@@ -15917,7 +15917,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::difference_type arg2 ;
@@ -15930,12 +15930,12 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___delitem____SWIG_0(PyObject *se
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___delitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___delitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t___delitem__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T___delitem__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< unsigned long >::difference_type >(val2);
   try {
@@ -15952,7 +15952,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -15964,12 +15964,12 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___getitem____SWIG_0(PyObject *se
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___getitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___getitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -15987,7 +15987,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -16000,12 +16000,12 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setitem____SWIG_0(PyObject *se
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___setitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___setitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -16013,10 +16013,10 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setitem____SWIG_0(PyObject *se
     std::vector< unsigned long,std::allocator< unsigned long > > *ptr = (std::vector< unsigned long,std::allocator< unsigned long > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_longinteger_t___setitem__" "', argument " "3"" of type '" "std::vector< unsigned long,std::allocator< unsigned long > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_longinteger_T___setitem__" "', argument " "3"" of type '" "std::vector< unsigned long,std::allocator< unsigned long > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_longinteger_t___setitem__" "', argument " "3"" of type '" "std::vector< unsigned long,std::allocator< unsigned long > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_longinteger_T___setitem__" "', argument " "3"" of type '" "std::vector< unsigned long,std::allocator< unsigned long > > const &""'"); 
     }
     arg3 = ptr;
   }
@@ -16036,7 +16036,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -16047,12 +16047,12 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setitem____SWIG_1(PyObject *se
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___setitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___setitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -16070,7 +16070,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -16081,12 +16081,12 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___delitem____SWIG_1(PyObject *se
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___delitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___delitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -16104,13 +16104,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___delitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___delitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_t___delitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_T___delitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -16121,7 +16121,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___delitem__(PyObject *self, PyOb
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_longinteger_t___delitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_longinteger_T___delitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -16135,13 +16135,13 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___delitem__(PyObject *self, PyOb
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_longinteger_t___delitem____SWIG_0(self, argc, argv);
+        return _wrap_vector_longinteger_T___delitem____SWIG_0(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_t___delitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_T___delitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< unsigned long >::__delitem__(std::vector< unsigned long >::difference_type)\n"
     "    std::vector< unsigned long >::__delitem__(SWIGPY_SLICEOBJECT *)\n");
@@ -16149,7 +16149,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::difference_type arg2 ;
@@ -16163,12 +16163,12 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___getitem____SWIG_1(PyObject *se
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___getitem__" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___getitem__" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t___getitem__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T___getitem__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< unsigned long >::difference_type >(val2);
   try {
@@ -16184,13 +16184,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___getitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___getitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_t___getitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_T___getitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -16201,7 +16201,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___getitem__(PyObject *self, PyOb
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_longinteger_t___getitem____SWIG_0(self, argc, argv);
+        return _wrap_vector_longinteger_T___getitem____SWIG_0(self, argc, argv);
       }
     }
   }
@@ -16215,13 +16215,13 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___getitem__(PyObject *self, PyOb
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_longinteger_t___getitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_longinteger_T___getitem____SWIG_1(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_t___getitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_T___getitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< unsigned long >::__getitem__(SWIGPY_SLICEOBJECT *)\n"
     "    std::vector< unsigned long >::__getitem__(std::vector< unsigned long >::difference_type) const\n");
@@ -16229,7 +16229,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::difference_type arg2 ;
@@ -16246,17 +16246,17 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setitem____SWIG_2(PyObject *se
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___setitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___setitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t___setitem__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T___setitem__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< unsigned long >::difference_type >(val2);
   ecode3 = SWIG_AsVal_unsigned_SS_long(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_t___setitem__" "', argument " "3"" of type '" "std::vector< unsigned long >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_T___setitem__" "', argument " "3"" of type '" "std::vector< unsigned long >::value_type""'");
   } 
   temp3 = static_cast< std::vector< unsigned long >::value_type >(val3);
   arg3 = &temp3;
@@ -16272,13 +16272,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___setitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___setitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_t___setitem__", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_T___setitem__", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -16289,7 +16289,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setitem__(PyObject *self, PyOb
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_longinteger_t___setitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_longinteger_T___setitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -16305,7 +16305,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setitem__(PyObject *self, PyOb
         int res = swig::asptr(argv[2], (std::vector< unsigned long,std::allocator< unsigned long > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vector_longinteger_t___setitem____SWIG_0(self, argc, argv);
+          return _wrap_vector_longinteger_T___setitem____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -16325,14 +16325,14 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setitem__(PyObject *self, PyOb
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_longinteger_t___setitem____SWIG_2(self, argc, argv);
+          return _wrap_vector_longinteger_T___setitem____SWIG_2(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_t___setitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_T___setitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< unsigned long >::__setitem__(SWIGPY_SLICEOBJECT *,std::vector< unsigned long,std::allocator< unsigned long > > const &)\n"
     "    std::vector< unsigned long >::__setitem__(SWIGPY_SLICEOBJECT *)\n"
@@ -16341,7 +16341,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_pop(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_pop(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -16354,7 +16354,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_pop(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_pop" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_pop" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   try {
@@ -16369,7 +16369,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_append(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_append(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::value_type *arg2 = 0 ;
@@ -16381,15 +16381,15 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_append(PyObject *self, PyObject
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_t_append", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_T_append", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_append" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_append" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_unsigned_SS_long(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t_append" "', argument " "2"" of type '" "std::vector< unsigned long >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T_append" "', argument " "2"" of type '" "std::vector< unsigned long >::value_type""'");
   } 
   temp2 = static_cast< std::vector< unsigned long >::value_type >(val2);
   arg2 = &temp2;
@@ -16401,7 +16401,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_longinteger_t__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
+SWIGINTERN PyObject *_wrap_new_vector_longinteger_T__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *result = 0 ;
   
@@ -16415,7 +16415,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_longinteger_t__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_longinteger_T__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = 0 ;
   int res1 = SWIG_OLDOBJ ;
@@ -16427,10 +16427,10 @@ SWIGINTERN PyObject *_wrap_new_vector_longinteger_t__SWIG_1(PyObject *self, Py_s
     std::vector< unsigned long,std::allocator< unsigned long > > *ptr = (std::vector< unsigned long,std::allocator< unsigned long > > *)0;
     res1 = swig::asptr(swig_obj[0], &ptr);
     if (!SWIG_IsOK(res1)) {
-      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vector_longinteger_t" "', argument " "1"" of type '" "std::vector< unsigned long > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vector_longinteger_T" "', argument " "1"" of type '" "std::vector< unsigned long > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_longinteger_t" "', argument " "1"" of type '" "std::vector< unsigned long > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_longinteger_T" "', argument " "1"" of type '" "std::vector< unsigned long > const &""'"); 
     }
     arg1 = ptr;
   }
@@ -16444,7 +16444,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_empty(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_empty(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -16457,7 +16457,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_empty(PyObject *self, PyObject *
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_empty" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_empty" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = (bool)((std::vector< unsigned long > const *)arg1)->empty();
@@ -16468,7 +16468,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_size(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_size(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -16481,7 +16481,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_size(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_size" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_size" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = ((std::vector< unsigned long > const *)arg1)->size();
@@ -16492,7 +16492,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_swap(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_swap(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long > *arg2 = 0 ;
@@ -16503,18 +16503,18 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_swap(PyObject *self, PyObject *a
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_t_swap", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_T_swap", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_swap" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_swap" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], &argp2, SWIGTYPE_p_std__vectorT_unsigned_long_t,  0 );
   if (!SWIG_IsOK(res2)) {
-    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_longinteger_t_swap" "', argument " "2"" of type '" "std::vector< unsigned long > &""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_longinteger_T_swap" "', argument " "2"" of type '" "std::vector< unsigned long > &""'"); 
   }
   if (!argp2) {
-    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_longinteger_t_swap" "', argument " "2"" of type '" "std::vector< unsigned long > &""'"); 
+    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_longinteger_T_swap" "', argument " "2"" of type '" "std::vector< unsigned long > &""'"); 
   }
   arg2 = reinterpret_cast< std::vector< unsigned long > * >(argp2);
   (arg1)->swap(*arg2);
@@ -16525,7 +16525,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_begin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_begin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -16538,7 +16538,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_begin(PyObject *self, PyObject *
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_begin" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_begin" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = (arg1)->begin();
@@ -16550,7 +16550,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_end(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_end(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -16563,7 +16563,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_end(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_end" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_end" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = (arg1)->end();
@@ -16575,7 +16575,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_rbegin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_rbegin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -16588,7 +16588,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_rbegin(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_rbegin" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_rbegin" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = (arg1)->rbegin();
@@ -16600,7 +16600,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_rend(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_rend(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -16613,7 +16613,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_rend(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_rend" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_rend" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = (arg1)->rend();
@@ -16625,7 +16625,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_clear(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_clear(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -16637,7 +16637,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_clear(PyObject *self, PyObject *
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_clear" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_clear" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   (arg1)->clear();
@@ -16648,7 +16648,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_get_allocator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_get_allocator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -16661,7 +16661,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_get_allocator(PyObject *self, Py
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_get_allocator" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_get_allocator" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = ((std::vector< unsigned long > const *)arg1)->get_allocator();
@@ -16672,7 +16672,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_longinteger_t__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_longinteger_T__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long >::size_type arg1 ;
   size_t val1 ;
@@ -16683,7 +16683,7 @@ SWIGINTERN PyObject *_wrap_new_vector_longinteger_t__SWIG_2(PyObject *self, Py_s
   if ((nobjs < 1) || (nobjs > 1)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_longinteger_t" "', argument " "1"" of type '" "std::vector< unsigned long >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_longinteger_T" "', argument " "1"" of type '" "std::vector< unsigned long >::size_type""'");
   } 
   arg1 = static_cast< std::vector< unsigned long >::size_type >(val1);
   result = (std::vector< unsigned long > *)new std::vector< unsigned long >(arg1);
@@ -16694,7 +16694,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_pop_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_pop_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -16706,7 +16706,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_pop_back(PyObject *self, PyObjec
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_pop_back" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_pop_back" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   (arg1)->pop_back();
@@ -16717,7 +16717,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::size_type arg2 ;
@@ -16730,12 +16730,12 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_resize__SWIG_0(PyObject *self, P
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_resize" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_resize" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t_resize" "', argument " "2"" of type '" "std::vector< unsigned long >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T_resize" "', argument " "2"" of type '" "std::vector< unsigned long >::size_type""'");
   } 
   arg2 = static_cast< std::vector< unsigned long >::size_type >(val2);
   (arg1)->resize(arg2);
@@ -16746,7 +16746,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::iterator arg2 ;
@@ -16760,18 +16760,18 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_erase__SWIG_0(PyObject *self, Py
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_erase" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_erase" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t_erase" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T_erase" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t_erase" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T_erase" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
     }
   }
   result = std_vector_Sl_unsigned_SS_long_Sg__erase__SWIG_0(arg1,SWIG_STD_MOVE(arg2));
@@ -16783,7 +16783,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::iterator arg2 ;
@@ -16800,29 +16800,29 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_erase__SWIG_1(PyObject *self, Py
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_erase" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_erase" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t_erase" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T_erase" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t_erase" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T_erase" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
     }
   }
   res3 = SWIG_ConvertPtr(swig_obj[2], SWIG_as_voidptrptr(&iter3), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res3) || !iter3) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t_erase" "', argument " "3"" of type '" "std::vector< unsigned long >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T_erase" "', argument " "3"" of type '" "std::vector< unsigned long >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *>(iter3);
     if (iter_t) {
       arg3 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t_erase" "', argument " "3"" of type '" "std::vector< unsigned long >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T_erase" "', argument " "3"" of type '" "std::vector< unsigned long >::iterator""'");
     }
   }
   result = std_vector_Sl_unsigned_SS_long_Sg__erase__SWIG_1(arg1,SWIG_STD_MOVE(arg2),SWIG_STD_MOVE(arg3));
@@ -16834,13 +16834,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_erase(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_erase(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_t_erase", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_T_erase", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -16851,7 +16851,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_erase(PyObject *self, PyObject *
       int res = SWIG_ConvertPtr(argv[1], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
       _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *>(iter) != 0));
       if (_v) {
-        return _wrap_vector_longinteger_t_erase__SWIG_0(self, argc, argv);
+        return _wrap_vector_longinteger_T_erase__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -16868,14 +16868,14 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_erase(PyObject *self, PyObject *
         int res = SWIG_ConvertPtr(argv[2], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
         _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *>(iter) != 0));
         if (_v) {
-          return _wrap_vector_longinteger_t_erase__SWIG_1(self, argc, argv);
+          return _wrap_vector_longinteger_T_erase__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_t_erase'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_T_erase'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< unsigned long >::erase(std::vector< unsigned long >::iterator)\n"
     "    std::vector< unsigned long >::erase(std::vector< unsigned long >::iterator,std::vector< unsigned long >::iterator)\n");
@@ -16883,7 +16883,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_longinteger_t__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_longinteger_T__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long >::size_type arg1 ;
   std::vector< unsigned long >::value_type *arg2 = 0 ;
@@ -16898,12 +16898,12 @@ SWIGINTERN PyObject *_wrap_new_vector_longinteger_t__SWIG_3(PyObject *self, Py_s
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_longinteger_t" "', argument " "1"" of type '" "std::vector< unsigned long >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_longinteger_T" "', argument " "1"" of type '" "std::vector< unsigned long >::size_type""'");
   } 
   arg1 = static_cast< std::vector< unsigned long >::size_type >(val1);
   ecode2 = SWIG_AsVal_unsigned_SS_long(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "new_vector_longinteger_t" "', argument " "2"" of type '" "std::vector< unsigned long >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "new_vector_longinteger_T" "', argument " "2"" of type '" "std::vector< unsigned long >::value_type""'");
   } 
   temp2 = static_cast< std::vector< unsigned long >::value_type >(val2);
   arg2 = &temp2;
@@ -16915,16 +16915,16 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_longinteger_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_new_vector_longinteger_T(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vector_longinteger_t", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vector_longinteger_T", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 0) {
-    return _wrap_new_vector_longinteger_t__SWIG_0(self, argc, argv);
+    return _wrap_new_vector_longinteger_T__SWIG_0(self, argc, argv);
   }
   if (argc == 1) {
     int _v = 0;
@@ -16933,7 +16933,7 @@ SWIGINTERN PyObject *_wrap_new_vector_longinteger_t(PyObject *self, PyObject *ar
       _v = SWIG_CheckState(res);
     }
     if (_v) {
-      return _wrap_new_vector_longinteger_t__SWIG_2(self, argc, argv);
+      return _wrap_new_vector_longinteger_T__SWIG_2(self, argc, argv);
     }
   }
   if (argc == 1) {
@@ -16941,7 +16941,7 @@ SWIGINTERN PyObject *_wrap_new_vector_longinteger_t(PyObject *self, PyObject *ar
     int res = swig::asptr(argv[0], (std::vector< unsigned long,std::allocator< unsigned long > >**)(0));
     _v = SWIG_CheckState(res);
     if (_v) {
-      return _wrap_new_vector_longinteger_t__SWIG_1(self, argc, argv);
+      return _wrap_new_vector_longinteger_T__SWIG_1(self, argc, argv);
     }
   }
   if (argc == 2) {
@@ -16956,13 +16956,13 @@ SWIGINTERN PyObject *_wrap_new_vector_longinteger_t(PyObject *self, PyObject *ar
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_new_vector_longinteger_t__SWIG_3(self, argc, argv);
+        return _wrap_new_vector_longinteger_T__SWIG_3(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vector_longinteger_t'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vector_longinteger_T'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< unsigned long >::vector()\n"
     "    std::vector< unsigned long >::vector(std::vector< unsigned long > const &)\n"
@@ -16972,7 +16972,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_push_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_push_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::value_type *arg2 = 0 ;
@@ -16984,15 +16984,15 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_push_back(PyObject *self, PyObje
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_t_push_back", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_T_push_back", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_push_back" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_push_back" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_unsigned_SS_long(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t_push_back" "', argument " "2"" of type '" "std::vector< unsigned long >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T_push_back" "', argument " "2"" of type '" "std::vector< unsigned long >::value_type""'");
   } 
   temp2 = static_cast< std::vector< unsigned long >::value_type >(val2);
   arg2 = &temp2;
@@ -17004,7 +17004,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_front(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_front(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -17017,7 +17017,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_front(PyObject *self, PyObject *
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_front" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_front" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = (std::vector< unsigned long >::value_type *) &((std::vector< unsigned long > const *)arg1)->front();
@@ -17029,7 +17029,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -17042,7 +17042,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_back(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_back" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_back" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = (std::vector< unsigned long >::value_type *) &((std::vector< unsigned long > const *)arg1)->back();
@@ -17054,7 +17054,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_assign(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_assign(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::size_type arg2 ;
@@ -17069,20 +17069,20 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_assign(PyObject *self, PyObject
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_t_assign", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_T_assign", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_assign" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_assign" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t_assign" "', argument " "2"" of type '" "std::vector< unsigned long >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T_assign" "', argument " "2"" of type '" "std::vector< unsigned long >::size_type""'");
   } 
   arg2 = static_cast< std::vector< unsigned long >::size_type >(val2);
   ecode3 = SWIG_AsVal_unsigned_SS_long(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_t_assign" "', argument " "3"" of type '" "std::vector< unsigned long >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_T_assign" "', argument " "3"" of type '" "std::vector< unsigned long >::value_type""'");
   } 
   temp3 = static_cast< std::vector< unsigned long >::value_type >(val3);
   arg3 = &temp3;
@@ -17094,7 +17094,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::size_type arg2 ;
@@ -17111,17 +17111,17 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_resize__SWIG_1(PyObject *self, P
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_resize" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_resize" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t_resize" "', argument " "2"" of type '" "std::vector< unsigned long >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T_resize" "', argument " "2"" of type '" "std::vector< unsigned long >::size_type""'");
   } 
   arg2 = static_cast< std::vector< unsigned long >::size_type >(val2);
   ecode3 = SWIG_AsVal_unsigned_SS_long(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_t_resize" "', argument " "3"" of type '" "std::vector< unsigned long >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_T_resize" "', argument " "3"" of type '" "std::vector< unsigned long >::value_type""'");
   } 
   temp3 = static_cast< std::vector< unsigned long >::value_type >(val3);
   arg3 = &temp3;
@@ -17133,13 +17133,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_resize(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_resize(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_t_resize", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_T_resize", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -17151,7 +17151,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_resize(PyObject *self, PyObject
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_longinteger_t_resize__SWIG_0(self, argc, argv);
+        return _wrap_vector_longinteger_T_resize__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -17170,14 +17170,14 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_resize(PyObject *self, PyObject
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_longinteger_t_resize__SWIG_1(self, argc, argv);
+          return _wrap_vector_longinteger_T_resize__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_t_resize'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_T_resize'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< unsigned long >::resize(std::vector< unsigned long >::size_type)\n"
     "    std::vector< unsigned long >::resize(std::vector< unsigned long >::size_type,std::vector< unsigned long >::value_type const &)\n");
@@ -17185,7 +17185,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::iterator arg2 ;
@@ -17203,23 +17203,23 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_insert__SWIG_0(PyObject *self, P
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_insert" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_insert" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t_insert" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T_insert" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t_insert" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T_insert" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_unsigned_SS_long(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_t_insert" "', argument " "3"" of type '" "std::vector< unsigned long >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_T_insert" "', argument " "3"" of type '" "std::vector< unsigned long >::value_type""'");
   } 
   temp3 = static_cast< std::vector< unsigned long >::value_type >(val3);
   arg3 = &temp3;
@@ -17232,7 +17232,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::iterator arg2 ;
@@ -17252,28 +17252,28 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_insert__SWIG_1(PyObject *self, P
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_insert" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_insert" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t_insert" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T_insert" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t_insert" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T_insert" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_size_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_t_insert" "', argument " "3"" of type '" "std::vector< unsigned long >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_T_insert" "', argument " "3"" of type '" "std::vector< unsigned long >::size_type""'");
   } 
   arg3 = static_cast< std::vector< unsigned long >::size_type >(val3);
   ecode4 = SWIG_AsVal_unsigned_SS_long(swig_obj[3], &val4);
   if (!SWIG_IsOK(ecode4)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode4), "in method '" "vector_longinteger_t_insert" "', argument " "4"" of type '" "std::vector< unsigned long >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode4), "in method '" "vector_longinteger_T_insert" "', argument " "4"" of type '" "std::vector< unsigned long >::value_type""'");
   } 
   temp4 = static_cast< std::vector< unsigned long >::value_type >(val4);
   arg4 = &temp4;
@@ -17285,13 +17285,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_insert(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_insert(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_t_insert", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_T_insert", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -17307,7 +17307,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_insert(PyObject *self, PyObject
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_longinteger_t_insert__SWIG_0(self, argc, argv);
+          return _wrap_vector_longinteger_T_insert__SWIG_0(self, argc, argv);
         }
       }
     }
@@ -17331,7 +17331,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_insert(PyObject *self, PyObject
             _v = SWIG_CheckState(res);
           }
           if (_v) {
-            return _wrap_vector_longinteger_t_insert__SWIG_1(self, argc, argv);
+            return _wrap_vector_longinteger_T_insert__SWIG_1(self, argc, argv);
           }
         }
       }
@@ -17339,7 +17339,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_insert(PyObject *self, PyObject
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_t_insert'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_T_insert'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< unsigned long >::insert(std::vector< unsigned long >::iterator,std::vector< unsigned long >::value_type const &)\n"
     "    std::vector< unsigned long >::insert(std::vector< unsigned long >::iterator,std::vector< unsigned long >::size_type,std::vector< unsigned long >::value_type const &)\n");
@@ -17347,7 +17347,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_reserve(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_reserve(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::size_type arg2 ;
@@ -17358,15 +17358,15 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_reserve(PyObject *self, PyObject
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_t_reserve", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_T_reserve", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_reserve" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_reserve" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t_reserve" "', argument " "2"" of type '" "std::vector< unsigned long >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T_reserve" "', argument " "2"" of type '" "std::vector< unsigned long >::size_type""'");
   } 
   arg2 = static_cast< std::vector< unsigned long >::size_type >(val2);
   (arg1)->reserve(arg2);
@@ -17377,7 +17377,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_capacity(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_capacity(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -17390,7 +17390,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_capacity(PyObject *self, PyObjec
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_capacity" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_capacity" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = ((std::vector< unsigned long > const *)arg1)->capacity();
@@ -17401,7 +17401,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_delete_vector_longinteger_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_delete_vector_longinteger_T(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -17413,7 +17413,7 @@ SWIGINTERN PyObject *_wrap_delete_vector_longinteger_t(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, SWIG_POINTER_DISOWN |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vector_longinteger_t" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vector_longinteger_T" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   {
@@ -17434,18 +17434,18 @@ fail:
 }
 
 
-SWIGINTERN PyObject *vector_longinteger_t_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vector_longinteger_T_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   PyObject *obj;
   if (!SWIG_Python_UnpackTuple(args, "swigregister", 1, 1, &obj)) return NULL;
   SWIG_TypeNewClientData(SWIGTYPE_p_std__vectorT_unsigned_long_t, SWIG_NewClientData(obj));
   return SWIG_Py_Void();
 }
 
-SWIGINTERN PyObject *vector_longinteger_t_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vector_longinteger_T_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   return SWIG_Python_InitShadowInstance(args);
 }
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_iterator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_iterator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   PyObject **arg2 = (PyObject **) 0 ;
@@ -17460,7 +17460,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_iterator(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_iterator" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_iterator" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = (swig::SwigPyIterator *)std_vector_Sl_std_complex_Sl_double_Sg__Sg__iterator(arg1,arg2);
@@ -17471,7 +17471,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___nonzero__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___nonzero__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -17484,7 +17484,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___nonzero__(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___nonzero__" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___nonzero__" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = (bool)std_vector_Sl_std_complex_Sl_double_Sg__Sg____nonzero__((std::vector< std::complex< double > > const *)arg1);
@@ -17495,7 +17495,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___bool__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___bool__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -17508,7 +17508,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___bool__(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___bool__" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___bool__" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = (bool)std_vector_Sl_std_complex_Sl_double_Sg__Sg____bool__((std::vector< std::complex< double > > const *)arg1);
@@ -17519,7 +17519,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___len__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___len__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -17532,7 +17532,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___len__(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___len__" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___len__" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = std_vector_Sl_std_complex_Sl_double_Sg__Sg____len__((std::vector< std::complex< double > > const *)arg1);
@@ -17543,7 +17543,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___getslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___getslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::difference_type arg2 ;
@@ -17558,20 +17558,20 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___getslice__(PyObject *self, PyObjec
   std::vector< std::complex< double >,std::allocator< std::complex< double > > > *result = 0 ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_complex_t___getslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_complex_T___getslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___getslice__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___getslice__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t___getslice__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T___getslice__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::complex< double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_t___getslice__" "', argument " "3"" of type '" "std::vector< std::complex< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_T___getslice__" "', argument " "3"" of type '" "std::vector< std::complex< double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::complex< double > >::difference_type >(val3);
   try {
@@ -17588,7 +17588,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::difference_type arg2 ;
@@ -17604,17 +17604,17 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setslice____SWIG_0(PyObject *self,
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___setslice__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___setslice__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t___setslice__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T___setslice__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::complex< double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_t___setslice__" "', argument " "3"" of type '" "std::vector< std::complex< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_T___setslice__" "', argument " "3"" of type '" "std::vector< std::complex< double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::complex< double > >::difference_type >(val3);
   try {
@@ -17631,7 +17631,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::difference_type arg2 ;
@@ -17649,27 +17649,27 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setslice____SWIG_1(PyObject *self,
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___setslice__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___setslice__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t___setslice__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T___setslice__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::complex< double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_t___setslice__" "', argument " "3"" of type '" "std::vector< std::complex< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_T___setslice__" "', argument " "3"" of type '" "std::vector< std::complex< double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::complex< double > >::difference_type >(val3);
   {
     std::vector< std::complex< double >,std::allocator< std::complex< double > > > *ptr = (std::vector< std::complex< double >,std::allocator< std::complex< double > > > *)0;
     res4 = swig::asptr(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_complex_t___setslice__" "', argument " "4"" of type '" "std::vector< std::complex< double >,std::allocator< std::complex< double > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_complex_T___setslice__" "', argument " "4"" of type '" "std::vector< std::complex< double >,std::allocator< std::complex< double > > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_complex_t___setslice__" "', argument " "4"" of type '" "std::vector< std::complex< double >,std::allocator< std::complex< double > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_complex_T___setslice__" "', argument " "4"" of type '" "std::vector< std::complex< double >,std::allocator< std::complex< double > > > const &""'"); 
     }
     arg4 = ptr;
   }
@@ -17689,13 +17689,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___setslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___setslice__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_t___setslice__", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_T___setslice__", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -17712,7 +17712,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setslice__(PyObject *self, PyObjec
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_complex_t___setslice____SWIG_0(self, argc, argv);
+          return _wrap_vector_complex_T___setslice____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -17735,7 +17735,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setslice__(PyObject *self, PyObjec
           int res = swig::asptr(argv[3], (std::vector< std::complex< double >,std::allocator< std::complex< double > > >**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vector_complex_t___setslice____SWIG_1(self, argc, argv);
+            return _wrap_vector_complex_T___setslice____SWIG_1(self, argc, argv);
           }
         }
       }
@@ -17743,7 +17743,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setslice__(PyObject *self, PyObjec
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_t___setslice__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_T___setslice__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::complex< double > >::__setslice__(std::vector< std::complex< double > >::difference_type,std::vector< std::complex< double > >::difference_type)\n"
     "    std::vector< std::complex< double > >::__setslice__(std::vector< std::complex< double > >::difference_type,std::vector< std::complex< double > >::difference_type,std::vector< std::complex< double >,std::allocator< std::complex< double > > > const &)\n");
@@ -17751,7 +17751,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___delslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___delslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::difference_type arg2 ;
@@ -17765,20 +17765,20 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___delslice__(PyObject *self, PyObjec
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_complex_t___delslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_complex_T___delslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___delslice__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___delslice__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t___delslice__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T___delslice__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::complex< double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_t___delslice__" "', argument " "3"" of type '" "std::vector< std::complex< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_T___delslice__" "', argument " "3"" of type '" "std::vector< std::complex< double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::complex< double > >::difference_type >(val3);
   try {
@@ -17795,7 +17795,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::difference_type arg2 ;
@@ -17808,12 +17808,12 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___delitem____SWIG_0(PyObject *self,
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___delitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___delitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t___delitem__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T___delitem__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::complex< double > >::difference_type >(val2);
   try {
@@ -17830,7 +17830,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -17842,12 +17842,12 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___getitem____SWIG_0(PyObject *self,
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___getitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___getitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -17865,7 +17865,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -17878,12 +17878,12 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setitem____SWIG_0(PyObject *self,
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___setitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___setitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -17891,10 +17891,10 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setitem____SWIG_0(PyObject *self,
     std::vector< std::complex< double >,std::allocator< std::complex< double > > > *ptr = (std::vector< std::complex< double >,std::allocator< std::complex< double > > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_complex_t___setitem__" "', argument " "3"" of type '" "std::vector< std::complex< double >,std::allocator< std::complex< double > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_complex_T___setitem__" "', argument " "3"" of type '" "std::vector< std::complex< double >,std::allocator< std::complex< double > > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_complex_t___setitem__" "', argument " "3"" of type '" "std::vector< std::complex< double >,std::allocator< std::complex< double > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_complex_T___setitem__" "', argument " "3"" of type '" "std::vector< std::complex< double >,std::allocator< std::complex< double > > > const &""'"); 
     }
     arg3 = ptr;
   }
@@ -17914,7 +17914,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -17925,12 +17925,12 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setitem____SWIG_1(PyObject *self,
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___setitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___setitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -17948,7 +17948,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -17959,12 +17959,12 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___delitem____SWIG_1(PyObject *self,
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___delitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___delitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -17982,13 +17982,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___delitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___delitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_t___delitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_T___delitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -17999,7 +17999,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___delitem__(PyObject *self, PyObject
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_complex_t___delitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_complex_T___delitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -18013,13 +18013,13 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___delitem__(PyObject *self, PyObject
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_complex_t___delitem____SWIG_0(self, argc, argv);
+        return _wrap_vector_complex_T___delitem____SWIG_0(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_t___delitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_T___delitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::complex< double > >::__delitem__(std::vector< std::complex< double > >::difference_type)\n"
     "    std::vector< std::complex< double > >::__delitem__(SWIGPY_SLICEOBJECT *)\n");
@@ -18027,7 +18027,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::difference_type arg2 ;
@@ -18041,12 +18041,12 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___getitem____SWIG_1(PyObject *self,
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___getitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___getitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t___getitem__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T___getitem__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::complex< double > >::difference_type >(val2);
   try {
@@ -18062,13 +18062,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___getitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___getitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_t___getitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_T___getitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -18079,7 +18079,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___getitem__(PyObject *self, PyObject
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_complex_t___getitem____SWIG_0(self, argc, argv);
+        return _wrap_vector_complex_T___getitem____SWIG_0(self, argc, argv);
       }
     }
   }
@@ -18093,13 +18093,13 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___getitem__(PyObject *self, PyObject
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_complex_t___getitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_complex_T___getitem____SWIG_1(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_t___getitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_T___getitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::complex< double > >::__getitem__(SWIGPY_SLICEOBJECT *)\n"
     "    std::vector< std::complex< double > >::__getitem__(std::vector< std::complex< double > >::difference_type) const\n");
@@ -18107,7 +18107,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::difference_type arg2 ;
@@ -18124,17 +18124,17 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setitem____SWIG_2(PyObject *self,
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___setitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___setitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t___setitem__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T___setitem__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::complex< double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_std_complex_Sl_double_Sg_(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_t___setitem__" "', argument " "3"" of type '" "std::vector< std::complex< double > >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_T___setitem__" "', argument " "3"" of type '" "std::vector< std::complex< double > >::value_type""'");
   } 
   temp3 = static_cast< std::vector< std::complex< double > >::value_type >(val3);
   arg3 = &temp3;
@@ -18150,13 +18150,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___setitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___setitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_t___setitem__", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_T___setitem__", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -18167,7 +18167,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setitem__(PyObject *self, PyObject
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_complex_t___setitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_complex_T___setitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -18183,7 +18183,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setitem__(PyObject *self, PyObject
         int res = swig::asptr(argv[2], (std::vector< std::complex< double >,std::allocator< std::complex< double > > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vector_complex_t___setitem____SWIG_0(self, argc, argv);
+          return _wrap_vector_complex_T___setitem____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -18203,14 +18203,14 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setitem__(PyObject *self, PyObject
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_complex_t___setitem____SWIG_2(self, argc, argv);
+          return _wrap_vector_complex_T___setitem____SWIG_2(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_t___setitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_T___setitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::complex< double > >::__setitem__(SWIGPY_SLICEOBJECT *,std::vector< std::complex< double >,std::allocator< std::complex< double > > > const &)\n"
     "    std::vector< std::complex< double > >::__setitem__(SWIGPY_SLICEOBJECT *)\n"
@@ -18219,7 +18219,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_pop(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_pop(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -18232,7 +18232,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_pop(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_pop" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_pop" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   try {
@@ -18247,7 +18247,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_append(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_append(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::value_type *arg2 = 0 ;
@@ -18259,15 +18259,15 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_append(PyObject *self, PyObject *arg
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_complex_t_append", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_complex_T_append", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_append" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_append" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_std_complex_Sl_double_Sg_(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t_append" "', argument " "2"" of type '" "std::vector< std::complex< double > >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T_append" "', argument " "2"" of type '" "std::vector< std::complex< double > >::value_type""'");
   } 
   temp2 = static_cast< std::vector< std::complex< double > >::value_type >(val2);
   arg2 = &temp2;
@@ -18279,7 +18279,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_complex_t__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
+SWIGINTERN PyObject *_wrap_new_vector_complex_T__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *result = 0 ;
   
@@ -18293,7 +18293,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_complex_t__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_complex_T__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = 0 ;
   int res1 = SWIG_OLDOBJ ;
@@ -18305,10 +18305,10 @@ SWIGINTERN PyObject *_wrap_new_vector_complex_t__SWIG_1(PyObject *self, Py_ssize
     std::vector< std::complex< double >,std::allocator< std::complex< double > > > *ptr = (std::vector< std::complex< double >,std::allocator< std::complex< double > > > *)0;
     res1 = swig::asptr(swig_obj[0], &ptr);
     if (!SWIG_IsOK(res1)) {
-      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vector_complex_t" "', argument " "1"" of type '" "std::vector< std::complex< double > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vector_complex_T" "', argument " "1"" of type '" "std::vector< std::complex< double > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_complex_t" "', argument " "1"" of type '" "std::vector< std::complex< double > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_complex_T" "', argument " "1"" of type '" "std::vector< std::complex< double > > const &""'"); 
     }
     arg1 = ptr;
   }
@@ -18322,7 +18322,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_empty(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_empty(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -18335,7 +18335,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_empty(PyObject *self, PyObject *args
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_empty" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_empty" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = (bool)((std::vector< std::complex< double > > const *)arg1)->empty();
@@ -18346,7 +18346,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_size(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_size(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -18359,7 +18359,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_size(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_size" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_size" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = ((std::vector< std::complex< double > > const *)arg1)->size();
@@ -18370,7 +18370,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_swap(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_swap(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > > *arg2 = 0 ;
@@ -18381,18 +18381,18 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_swap(PyObject *self, PyObject *args)
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_complex_t_swap", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_complex_T_swap", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_swap" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_swap" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], &argp2, SWIGTYPE_p_std__vectorT_std__complexT_double_t_t,  0 );
   if (!SWIG_IsOK(res2)) {
-    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_complex_t_swap" "', argument " "2"" of type '" "std::vector< std::complex< double > > &""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_complex_T_swap" "', argument " "2"" of type '" "std::vector< std::complex< double > > &""'"); 
   }
   if (!argp2) {
-    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_complex_t_swap" "', argument " "2"" of type '" "std::vector< std::complex< double > > &""'"); 
+    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_complex_T_swap" "', argument " "2"" of type '" "std::vector< std::complex< double > > &""'"); 
   }
   arg2 = reinterpret_cast< std::vector< std::complex< double > > * >(argp2);
   (arg1)->swap(*arg2);
@@ -18403,7 +18403,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_begin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_begin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -18416,7 +18416,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_begin(PyObject *self, PyObject *args
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_begin" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_begin" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = (arg1)->begin();
@@ -18428,7 +18428,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_end(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_end(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -18441,7 +18441,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_end(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_end" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_end" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = (arg1)->end();
@@ -18453,7 +18453,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_rbegin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_rbegin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -18466,7 +18466,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_rbegin(PyObject *self, PyObject *arg
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_rbegin" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_rbegin" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = (arg1)->rbegin();
@@ -18478,7 +18478,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_rend(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_rend(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -18491,7 +18491,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_rend(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_rend" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_rend" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = (arg1)->rend();
@@ -18503,7 +18503,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_clear(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_clear(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -18515,7 +18515,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_clear(PyObject *self, PyObject *args
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_clear" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_clear" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   (arg1)->clear();
@@ -18526,7 +18526,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_get_allocator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_get_allocator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -18539,7 +18539,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_get_allocator(PyObject *self, PyObje
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_get_allocator" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_get_allocator" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = ((std::vector< std::complex< double > > const *)arg1)->get_allocator();
@@ -18550,7 +18550,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_complex_t__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_complex_T__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > >::size_type arg1 ;
   size_t val1 ;
@@ -18561,7 +18561,7 @@ SWIGINTERN PyObject *_wrap_new_vector_complex_t__SWIG_2(PyObject *self, Py_ssize
   if ((nobjs < 1) || (nobjs > 1)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_complex_t" "', argument " "1"" of type '" "std::vector< std::complex< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_complex_T" "', argument " "1"" of type '" "std::vector< std::complex< double > >::size_type""'");
   } 
   arg1 = static_cast< std::vector< std::complex< double > >::size_type >(val1);
   result = (std::vector< std::complex< double > > *)new std::vector< std::complex< double > >(arg1);
@@ -18572,7 +18572,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_pop_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_pop_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -18584,7 +18584,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_pop_back(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_pop_back" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_pop_back" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   (arg1)->pop_back();
@@ -18595,7 +18595,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::size_type arg2 ;
@@ -18608,12 +18608,12 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_resize__SWIG_0(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_resize" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_resize" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t_resize" "', argument " "2"" of type '" "std::vector< std::complex< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T_resize" "', argument " "2"" of type '" "std::vector< std::complex< double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::complex< double > >::size_type >(val2);
   (arg1)->resize(arg2);
@@ -18624,7 +18624,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::iterator arg2 ;
@@ -18638,18 +18638,18 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_erase__SWIG_0(PyObject *self, Py_ssi
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_erase" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_erase" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t_erase" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T_erase" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t_erase" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T_erase" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
     }
   }
   result = std_vector_Sl_std_complex_Sl_double_Sg__Sg__erase__SWIG_0(arg1,SWIG_STD_MOVE(arg2));
@@ -18661,7 +18661,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::iterator arg2 ;
@@ -18678,29 +18678,29 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_erase__SWIG_1(PyObject *self, Py_ssi
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_erase" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_erase" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t_erase" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T_erase" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t_erase" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T_erase" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
     }
   }
   res3 = SWIG_ConvertPtr(swig_obj[2], SWIG_as_voidptrptr(&iter3), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res3) || !iter3) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t_erase" "', argument " "3"" of type '" "std::vector< std::complex< double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T_erase" "', argument " "3"" of type '" "std::vector< std::complex< double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *>(iter3);
     if (iter_t) {
       arg3 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t_erase" "', argument " "3"" of type '" "std::vector< std::complex< double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T_erase" "', argument " "3"" of type '" "std::vector< std::complex< double > >::iterator""'");
     }
   }
   result = std_vector_Sl_std_complex_Sl_double_Sg__Sg__erase__SWIG_1(arg1,SWIG_STD_MOVE(arg2),SWIG_STD_MOVE(arg3));
@@ -18712,13 +18712,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_erase(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_erase(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_t_erase", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_T_erase", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -18729,7 +18729,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_erase(PyObject *self, PyObject *args
       int res = SWIG_ConvertPtr(argv[1], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
       _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *>(iter) != 0));
       if (_v) {
-        return _wrap_vector_complex_t_erase__SWIG_0(self, argc, argv);
+        return _wrap_vector_complex_T_erase__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -18746,14 +18746,14 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_erase(PyObject *self, PyObject *args
         int res = SWIG_ConvertPtr(argv[2], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
         _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *>(iter) != 0));
         if (_v) {
-          return _wrap_vector_complex_t_erase__SWIG_1(self, argc, argv);
+          return _wrap_vector_complex_T_erase__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_t_erase'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_T_erase'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::complex< double > >::erase(std::vector< std::complex< double > >::iterator)\n"
     "    std::vector< std::complex< double > >::erase(std::vector< std::complex< double > >::iterator,std::vector< std::complex< double > >::iterator)\n");
@@ -18761,7 +18761,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_complex_t__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_complex_T__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > >::size_type arg1 ;
   std::vector< std::complex< double > >::value_type *arg2 = 0 ;
@@ -18776,12 +18776,12 @@ SWIGINTERN PyObject *_wrap_new_vector_complex_t__SWIG_3(PyObject *self, Py_ssize
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_complex_t" "', argument " "1"" of type '" "std::vector< std::complex< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_complex_T" "', argument " "1"" of type '" "std::vector< std::complex< double > >::size_type""'");
   } 
   arg1 = static_cast< std::vector< std::complex< double > >::size_type >(val1);
   ecode2 = SWIG_AsVal_std_complex_Sl_double_Sg_(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "new_vector_complex_t" "', argument " "2"" of type '" "std::vector< std::complex< double > >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "new_vector_complex_T" "', argument " "2"" of type '" "std::vector< std::complex< double > >::value_type""'");
   } 
   temp2 = static_cast< std::vector< std::complex< double > >::value_type >(val2);
   arg2 = &temp2;
@@ -18793,16 +18793,16 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_complex_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_new_vector_complex_T(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vector_complex_t", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vector_complex_T", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 0) {
-    return _wrap_new_vector_complex_t__SWIG_0(self, argc, argv);
+    return _wrap_new_vector_complex_T__SWIG_0(self, argc, argv);
   }
   if (argc == 1) {
     int _v = 0;
@@ -18811,7 +18811,7 @@ SWIGINTERN PyObject *_wrap_new_vector_complex_t(PyObject *self, PyObject *args)
       _v = SWIG_CheckState(res);
     }
     if (_v) {
-      return _wrap_new_vector_complex_t__SWIG_2(self, argc, argv);
+      return _wrap_new_vector_complex_T__SWIG_2(self, argc, argv);
     }
   }
   if (argc == 1) {
@@ -18819,7 +18819,7 @@ SWIGINTERN PyObject *_wrap_new_vector_complex_t(PyObject *self, PyObject *args)
     int res = swig::asptr(argv[0], (std::vector< std::complex< double >,std::allocator< std::complex< double > > >**)(0));
     _v = SWIG_CheckState(res);
     if (_v) {
-      return _wrap_new_vector_complex_t__SWIG_1(self, argc, argv);
+      return _wrap_new_vector_complex_T__SWIG_1(self, argc, argv);
     }
   }
   if (argc == 2) {
@@ -18834,13 +18834,13 @@ SWIGINTERN PyObject *_wrap_new_vector_complex_t(PyObject *self, PyObject *args)
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_new_vector_complex_t__SWIG_3(self, argc, argv);
+        return _wrap_new_vector_complex_T__SWIG_3(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vector_complex_t'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vector_complex_T'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::complex< double > >::vector()\n"
     "    std::vector< std::complex< double > >::vector(std::vector< std::complex< double > > const &)\n"
@@ -18850,7 +18850,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_push_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_push_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::value_type *arg2 = 0 ;
@@ -18862,15 +18862,15 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_push_back(PyObject *self, PyObject *
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_complex_t_push_back", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_complex_T_push_back", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_push_back" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_push_back" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_std_complex_Sl_double_Sg_(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t_push_back" "', argument " "2"" of type '" "std::vector< std::complex< double > >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T_push_back" "', argument " "2"" of type '" "std::vector< std::complex< double > >::value_type""'");
   } 
   temp2 = static_cast< std::vector< std::complex< double > >::value_type >(val2);
   arg2 = &temp2;
@@ -18882,7 +18882,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_front(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_front(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -18895,7 +18895,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_front(PyObject *self, PyObject *args
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_front" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_front" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = (std::vector< std::complex< double > >::value_type *) &((std::vector< std::complex< double > > const *)arg1)->front();
@@ -18907,7 +18907,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -18920,7 +18920,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_back(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_back" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_back" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = (std::vector< std::complex< double > >::value_type *) &((std::vector< std::complex< double > > const *)arg1)->back();
@@ -18932,7 +18932,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_assign(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_assign(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::size_type arg2 ;
@@ -18947,20 +18947,20 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_assign(PyObject *self, PyObject *arg
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_complex_t_assign", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_complex_T_assign", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_assign" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_assign" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t_assign" "', argument " "2"" of type '" "std::vector< std::complex< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T_assign" "', argument " "2"" of type '" "std::vector< std::complex< double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::complex< double > >::size_type >(val2);
   ecode3 = SWIG_AsVal_std_complex_Sl_double_Sg_(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_t_assign" "', argument " "3"" of type '" "std::vector< std::complex< double > >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_T_assign" "', argument " "3"" of type '" "std::vector< std::complex< double > >::value_type""'");
   } 
   temp3 = static_cast< std::vector< std::complex< double > >::value_type >(val3);
   arg3 = &temp3;
@@ -18972,7 +18972,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::size_type arg2 ;
@@ -18989,17 +18989,17 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_resize__SWIG_1(PyObject *self, Py_ss
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_resize" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_resize" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t_resize" "', argument " "2"" of type '" "std::vector< std::complex< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T_resize" "', argument " "2"" of type '" "std::vector< std::complex< double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::complex< double > >::size_type >(val2);
   ecode3 = SWIG_AsVal_std_complex_Sl_double_Sg_(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_t_resize" "', argument " "3"" of type '" "std::vector< std::complex< double > >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_T_resize" "', argument " "3"" of type '" "std::vector< std::complex< double > >::value_type""'");
   } 
   temp3 = static_cast< std::vector< std::complex< double > >::value_type >(val3);
   arg3 = &temp3;
@@ -19011,13 +19011,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_resize(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_resize(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_t_resize", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_T_resize", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -19029,7 +19029,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_resize(PyObject *self, PyObject *arg
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_complex_t_resize__SWIG_0(self, argc, argv);
+        return _wrap_vector_complex_T_resize__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -19048,14 +19048,14 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_resize(PyObject *self, PyObject *arg
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_complex_t_resize__SWIG_1(self, argc, argv);
+          return _wrap_vector_complex_T_resize__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_t_resize'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_T_resize'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::complex< double > >::resize(std::vector< std::complex< double > >::size_type)\n"
     "    std::vector< std::complex< double > >::resize(std::vector< std::complex< double > >::size_type,std::vector< std::complex< double > >::value_type const &)\n");
@@ -19063,7 +19063,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::iterator arg2 ;
@@ -19081,23 +19081,23 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_insert__SWIG_0(PyObject *self, Py_ss
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_insert" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_insert" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t_insert" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T_insert" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t_insert" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T_insert" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_std_complex_Sl_double_Sg_(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_t_insert" "', argument " "3"" of type '" "std::vector< std::complex< double > >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_T_insert" "', argument " "3"" of type '" "std::vector< std::complex< double > >::value_type""'");
   } 
   temp3 = static_cast< std::vector< std::complex< double > >::value_type >(val3);
   arg3 = &temp3;
@@ -19110,7 +19110,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::iterator arg2 ;
@@ -19130,28 +19130,28 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_insert__SWIG_1(PyObject *self, Py_ss
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_insert" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_insert" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t_insert" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T_insert" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t_insert" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T_insert" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_size_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_t_insert" "', argument " "3"" of type '" "std::vector< std::complex< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_T_insert" "', argument " "3"" of type '" "std::vector< std::complex< double > >::size_type""'");
   } 
   arg3 = static_cast< std::vector< std::complex< double > >::size_type >(val3);
   ecode4 = SWIG_AsVal_std_complex_Sl_double_Sg_(swig_obj[3], &val4);
   if (!SWIG_IsOK(ecode4)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode4), "in method '" "vector_complex_t_insert" "', argument " "4"" of type '" "std::vector< std::complex< double > >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode4), "in method '" "vector_complex_T_insert" "', argument " "4"" of type '" "std::vector< std::complex< double > >::value_type""'");
   } 
   temp4 = static_cast< std::vector< std::complex< double > >::value_type >(val4);
   arg4 = &temp4;
@@ -19163,13 +19163,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_insert(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_insert(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_t_insert", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_T_insert", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -19185,7 +19185,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_insert(PyObject *self, PyObject *arg
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_complex_t_insert__SWIG_0(self, argc, argv);
+          return _wrap_vector_complex_T_insert__SWIG_0(self, argc, argv);
         }
       }
     }
@@ -19209,7 +19209,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_insert(PyObject *self, PyObject *arg
             _v = SWIG_CheckState(res);
           }
           if (_v) {
-            return _wrap_vector_complex_t_insert__SWIG_1(self, argc, argv);
+            return _wrap_vector_complex_T_insert__SWIG_1(self, argc, argv);
           }
         }
       }
@@ -19217,7 +19217,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_insert(PyObject *self, PyObject *arg
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_t_insert'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_T_insert'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::complex< double > >::insert(std::vector< std::complex< double > >::iterator,std::vector< std::complex< double > >::value_type const &)\n"
     "    std::vector< std::complex< double > >::insert(std::vector< std::complex< double > >::iterator,std::vector< std::complex< double > >::size_type,std::vector< std::complex< double > >::value_type const &)\n");
@@ -19225,7 +19225,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_reserve(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_reserve(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::size_type arg2 ;
@@ -19236,15 +19236,15 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_reserve(PyObject *self, PyObject *ar
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_complex_t_reserve", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_complex_T_reserve", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_reserve" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_reserve" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t_reserve" "', argument " "2"" of type '" "std::vector< std::complex< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T_reserve" "', argument " "2"" of type '" "std::vector< std::complex< double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::complex< double > >::size_type >(val2);
   (arg1)->reserve(arg2);
@@ -19255,7 +19255,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_capacity(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_capacity(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -19268,7 +19268,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_capacity(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_capacity" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_capacity" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = ((std::vector< std::complex< double > > const *)arg1)->capacity();
@@ -19279,7 +19279,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_delete_vector_complex_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_delete_vector_complex_T(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -19291,7 +19291,7 @@ SWIGINTERN PyObject *_wrap_delete_vector_complex_t(PyObject *self, PyObject *arg
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, SWIG_POINTER_DISOWN |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vector_complex_t" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vector_complex_T" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   {
@@ -19312,18 +19312,18 @@ fail:
 }
 
 
-SWIGINTERN PyObject *vector_complex_t_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vector_complex_T_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   PyObject *obj;
   if (!SWIG_Python_UnpackTuple(args, "swigregister", 1, 1, &obj)) return NULL;
   SWIG_TypeNewClientData(SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, SWIG_NewClientData(obj));
   return SWIG_Py_Void();
 }
 
-SWIGINTERN PyObject *vector_complex_t_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vector_complex_T_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   return SWIG_Python_InitShadowInstance(args);
 }
 
-SWIGINTERN PyObject *_wrap_vector_string_t_iterator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_iterator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   PyObject **arg2 = (PyObject **) 0 ;
@@ -19338,7 +19338,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_iterator(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_iterator" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_iterator" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = (swig::SwigPyIterator *)std_vector_Sl_std_string_Sg__iterator(arg1,arg2);
@@ -19349,7 +19349,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___nonzero__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T___nonzero__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -19362,7 +19362,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t___nonzero__(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___nonzero__" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___nonzero__" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = (bool)std_vector_Sl_std_string_Sg____nonzero__((std::vector< std::string > const *)arg1);
@@ -19373,7 +19373,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___bool__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T___bool__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -19386,7 +19386,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t___bool__(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___bool__" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___bool__" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = (bool)std_vector_Sl_std_string_Sg____bool__((std::vector< std::string > const *)arg1);
@@ -19397,7 +19397,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___len__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T___len__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -19410,7 +19410,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t___len__(PyObject *self, PyObject *arg
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___len__" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___len__" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = std_vector_Sl_std_string_Sg____len__((std::vector< std::string > const *)arg1);
@@ -19421,7 +19421,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___getslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T___getslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::difference_type arg2 ;
@@ -19436,20 +19436,20 @@ SWIGINTERN PyObject *_wrap_vector_string_t___getslice__(PyObject *self, PyObject
   std::vector< std::string,std::allocator< std::string > > *result = 0 ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_string_t___getslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_string_T___getslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___getslice__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___getslice__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_t___getslice__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_T___getslice__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::string >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_string_t___getslice__" "', argument " "3"" of type '" "std::vector< std::string >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_string_T___getslice__" "', argument " "3"" of type '" "std::vector< std::string >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::string >::difference_type >(val3);
   try {
@@ -19466,7 +19466,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::difference_type arg2 ;
@@ -19482,17 +19482,17 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setslice____SWIG_0(PyObject *self,
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___setslice__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___setslice__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_t___setslice__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_T___setslice__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::string >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_string_t___setslice__" "', argument " "3"" of type '" "std::vector< std::string >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_string_T___setslice__" "', argument " "3"" of type '" "std::vector< std::string >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::string >::difference_type >(val3);
   try {
@@ -19509,7 +19509,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::difference_type arg2 ;
@@ -19527,27 +19527,27 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setslice____SWIG_1(PyObject *self,
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___setslice__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___setslice__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_t___setslice__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_T___setslice__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::string >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_string_t___setslice__" "', argument " "3"" of type '" "std::vector< std::string >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_string_T___setslice__" "', argument " "3"" of type '" "std::vector< std::string >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::string >::difference_type >(val3);
   {
     std::vector< std::string,std::allocator< std::string > > *ptr = (std::vector< std::string,std::allocator< std::string > > *)0;
     res4 = swig::asptr(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_string_t___setslice__" "', argument " "4"" of type '" "std::vector< std::string,std::allocator< std::string > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_string_T___setslice__" "', argument " "4"" of type '" "std::vector< std::string,std::allocator< std::string > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_t___setslice__" "', argument " "4"" of type '" "std::vector< std::string,std::allocator< std::string > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_T___setslice__" "', argument " "4"" of type '" "std::vector< std::string,std::allocator< std::string > > const &""'"); 
     }
     arg4 = ptr;
   }
@@ -19567,13 +19567,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___setslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T___setslice__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_t___setslice__", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_T___setslice__", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -19590,7 +19590,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setslice__(PyObject *self, PyObject
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_string_t___setslice____SWIG_0(self, argc, argv);
+          return _wrap_vector_string_T___setslice____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -19613,7 +19613,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setslice__(PyObject *self, PyObject
           int res = swig::asptr(argv[3], (std::vector< std::string,std::allocator< std::string > >**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vector_string_t___setslice____SWIG_1(self, argc, argv);
+            return _wrap_vector_string_T___setslice____SWIG_1(self, argc, argv);
           }
         }
       }
@@ -19621,7 +19621,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setslice__(PyObject *self, PyObject
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_t___setslice__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_T___setslice__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::string >::__setslice__(std::vector< std::string >::difference_type,std::vector< std::string >::difference_type)\n"
     "    std::vector< std::string >::__setslice__(std::vector< std::string >::difference_type,std::vector< std::string >::difference_type,std::vector< std::string,std::allocator< std::string > > const &)\n");
@@ -19629,7 +19629,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___delslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T___delslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::difference_type arg2 ;
@@ -19643,20 +19643,20 @@ SWIGINTERN PyObject *_wrap_vector_string_t___delslice__(PyObject *self, PyObject
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_string_t___delslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_string_T___delslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___delslice__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___delslice__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_t___delslice__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_T___delslice__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::string >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_string_t___delslice__" "', argument " "3"" of type '" "std::vector< std::string >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_string_T___delslice__" "', argument " "3"" of type '" "std::vector< std::string >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::string >::difference_type >(val3);
   try {
@@ -19673,7 +19673,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::difference_type arg2 ;
@@ -19686,12 +19686,12 @@ SWIGINTERN PyObject *_wrap_vector_string_t___delitem____SWIG_0(PyObject *self, P
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___delitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___delitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_t___delitem__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_T___delitem__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::string >::difference_type >(val2);
   try {
@@ -19708,7 +19708,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -19720,12 +19720,12 @@ SWIGINTERN PyObject *_wrap_vector_string_t___getitem____SWIG_0(PyObject *self, P
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___getitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___getitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -19743,7 +19743,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -19756,12 +19756,12 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setitem____SWIG_0(PyObject *self, P
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___setitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___setitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -19769,10 +19769,10 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setitem____SWIG_0(PyObject *self, P
     std::vector< std::string,std::allocator< std::string > > *ptr = (std::vector< std::string,std::allocator< std::string > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_string_t___setitem__" "', argument " "3"" of type '" "std::vector< std::string,std::allocator< std::string > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_string_T___setitem__" "', argument " "3"" of type '" "std::vector< std::string,std::allocator< std::string > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_t___setitem__" "', argument " "3"" of type '" "std::vector< std::string,std::allocator< std::string > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_T___setitem__" "', argument " "3"" of type '" "std::vector< std::string,std::allocator< std::string > > const &""'"); 
     }
     arg3 = ptr;
   }
@@ -19792,7 +19792,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -19803,12 +19803,12 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setitem____SWIG_1(PyObject *self, P
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___setitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___setitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -19826,7 +19826,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -19837,12 +19837,12 @@ SWIGINTERN PyObject *_wrap_vector_string_t___delitem____SWIG_1(PyObject *self, P
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___delitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___delitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -19860,13 +19860,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___delitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T___delitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_t___delitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_T___delitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -19877,7 +19877,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t___delitem__(PyObject *self, PyObject
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_string_t___delitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_string_T___delitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -19891,13 +19891,13 @@ SWIGINTERN PyObject *_wrap_vector_string_t___delitem__(PyObject *self, PyObject
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_string_t___delitem____SWIG_0(self, argc, argv);
+        return _wrap_vector_string_T___delitem____SWIG_0(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_t___delitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_T___delitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::string >::__delitem__(std::vector< std::string >::difference_type)\n"
     "    std::vector< std::string >::__delitem__(SWIGPY_SLICEOBJECT *)\n");
@@ -19905,7 +19905,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::difference_type arg2 ;
@@ -19919,12 +19919,12 @@ SWIGINTERN PyObject *_wrap_vector_string_t___getitem____SWIG_1(PyObject *self, P
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___getitem__" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___getitem__" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_t___getitem__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_T___getitem__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::string >::difference_type >(val2);
   try {
@@ -19940,13 +19940,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___getitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T___getitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_t___getitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_T___getitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -19957,7 +19957,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t___getitem__(PyObject *self, PyObject
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_string_t___getitem____SWIG_0(self, argc, argv);
+        return _wrap_vector_string_T___getitem____SWIG_0(self, argc, argv);
       }
     }
   }
@@ -19971,13 +19971,13 @@ SWIGINTERN PyObject *_wrap_vector_string_t___getitem__(PyObject *self, PyObject
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_string_t___getitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_string_T___getitem____SWIG_1(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_t___getitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_T___getitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::string >::__getitem__(SWIGPY_SLICEOBJECT *)\n"
     "    std::vector< std::string >::__getitem__(std::vector< std::string >::difference_type) const\n");
@@ -19985,7 +19985,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::difference_type arg2 ;
@@ -20000,22 +20000,22 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setitem____SWIG_2(PyObject *self, P
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___setitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___setitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_t___setitem__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_T___setitem__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::string >::difference_type >(val2);
   {
     std::string *ptr = (std::string *)0;
     res3 = SWIG_AsPtr_std_string(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_string_t___setitem__" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_string_T___setitem__" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_t___setitem__" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_T___setitem__" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -20033,13 +20033,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___setitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T___setitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_t___setitem__", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_T___setitem__", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -20050,7 +20050,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setitem__(PyObject *self, PyObject
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_string_t___setitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_string_T___setitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -20066,7 +20066,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setitem__(PyObject *self, PyObject
         int res = swig::asptr(argv[2], (std::vector< std::string,std::allocator< std::string > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vector_string_t___setitem____SWIG_0(self, argc, argv);
+          return _wrap_vector_string_T___setitem____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -20084,14 +20084,14 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setitem__(PyObject *self, PyObject
         int res = SWIG_AsPtr_std_string(argv[2], (std::string**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vector_string_t___setitem____SWIG_2(self, argc, argv);
+          return _wrap_vector_string_T___setitem____SWIG_2(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_t___setitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_T___setitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::string >::__setitem__(SWIGPY_SLICEOBJECT *,std::vector< std::string,std::allocator< std::string > > const &)\n"
     "    std::vector< std::string >::__setitem__(SWIGPY_SLICEOBJECT *)\n"
@@ -20100,7 +20100,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_pop(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_pop(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -20113,7 +20113,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_pop(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_pop" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_pop" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   try {
@@ -20128,7 +20128,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_append(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_append(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::value_type *arg2 = 0 ;
@@ -20138,20 +20138,20 @@ SWIGINTERN PyObject *_wrap_vector_string_t_append(PyObject *self, PyObject *args
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_string_t_append", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_string_T_append", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_append" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_append" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_string_t_append" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_string_T_append" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_t_append" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_T_append" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -20165,7 +20165,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_string_t__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
+SWIGINTERN PyObject *_wrap_new_vector_string_T__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
   PyObject *resultobj = 0;
   std::vector< std::string > *result = 0 ;
   
@@ -20179,7 +20179,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_string_t__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_string_T__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = 0 ;
   int res1 = SWIG_OLDOBJ ;
@@ -20191,10 +20191,10 @@ SWIGINTERN PyObject *_wrap_new_vector_string_t__SWIG_1(PyObject *self, Py_ssize_
     std::vector< std::string,std::allocator< std::string > > *ptr = (std::vector< std::string,std::allocator< std::string > > *)0;
     res1 = swig::asptr(swig_obj[0], &ptr);
     if (!SWIG_IsOK(res1)) {
-      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vector_string_t" "', argument " "1"" of type '" "std::vector< std::string > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vector_string_T" "', argument " "1"" of type '" "std::vector< std::string > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_string_t" "', argument " "1"" of type '" "std::vector< std::string > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_string_T" "', argument " "1"" of type '" "std::vector< std::string > const &""'"); 
     }
     arg1 = ptr;
   }
@@ -20208,7 +20208,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_empty(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_empty(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -20221,7 +20221,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_empty(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_empty" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_empty" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = (bool)((std::vector< std::string > const *)arg1)->empty();
@@ -20232,7 +20232,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_size(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_size(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -20245,7 +20245,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_size(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_size" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_size" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = ((std::vector< std::string > const *)arg1)->size();
@@ -20256,7 +20256,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_swap(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_swap(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string > *arg2 = 0 ;
@@ -20267,18 +20267,18 @@ SWIGINTERN PyObject *_wrap_vector_string_t_swap(PyObject *self, PyObject *args)
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_string_t_swap", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_string_T_swap", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_swap" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_swap" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], &argp2, SWIGTYPE_p_std__vectorT_std__string_t,  0 );
   if (!SWIG_IsOK(res2)) {
-    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_string_t_swap" "', argument " "2"" of type '" "std::vector< std::string > &""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_string_T_swap" "', argument " "2"" of type '" "std::vector< std::string > &""'"); 
   }
   if (!argp2) {
-    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_t_swap" "', argument " "2"" of type '" "std::vector< std::string > &""'"); 
+    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_T_swap" "', argument " "2"" of type '" "std::vector< std::string > &""'"); 
   }
   arg2 = reinterpret_cast< std::vector< std::string > * >(argp2);
   (arg1)->swap(*arg2);
@@ -20289,7 +20289,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_begin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_begin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -20302,7 +20302,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_begin(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_begin" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_begin" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = (arg1)->begin();
@@ -20314,7 +20314,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_end(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_end(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -20327,7 +20327,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_end(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_end" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_end" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = (arg1)->end();
@@ -20339,7 +20339,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_rbegin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_rbegin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -20352,7 +20352,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_rbegin(PyObject *self, PyObject *args
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_rbegin" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_rbegin" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = (arg1)->rbegin();
@@ -20364,7 +20364,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_rend(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_rend(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -20377,7 +20377,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_rend(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_rend" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_rend" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = (arg1)->rend();
@@ -20389,7 +20389,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_clear(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_clear(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -20401,7 +20401,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_clear(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_clear" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_clear" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   (arg1)->clear();
@@ -20412,7 +20412,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_get_allocator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_get_allocator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -20425,7 +20425,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_get_allocator(PyObject *self, PyObjec
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_get_allocator" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_get_allocator" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = ((std::vector< std::string > const *)arg1)->get_allocator();
@@ -20436,7 +20436,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_string_t__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_string_T__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string >::size_type arg1 ;
   size_t val1 ;
@@ -20447,7 +20447,7 @@ SWIGINTERN PyObject *_wrap_new_vector_string_t__SWIG_2(PyObject *self, Py_ssize_
   if ((nobjs < 1) || (nobjs > 1)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_string_t" "', argument " "1"" of type '" "std::vector< std::string >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_string_T" "', argument " "1"" of type '" "std::vector< std::string >::size_type""'");
   } 
   arg1 = static_cast< std::vector< std::string >::size_type >(val1);
   result = (std::vector< std::string > *)new std::vector< std::string >(arg1);
@@ -20458,7 +20458,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_pop_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_pop_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -20470,7 +20470,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_pop_back(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_pop_back" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_pop_back" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   (arg1)->pop_back();
@@ -20481,7 +20481,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::size_type arg2 ;
@@ -20494,12 +20494,12 @@ SWIGINTERN PyObject *_wrap_vector_string_t_resize__SWIG_0(PyObject *self, Py_ssi
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_resize" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_resize" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_t_resize" "', argument " "2"" of type '" "std::vector< std::string >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_T_resize" "', argument " "2"" of type '" "std::vector< std::string >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::string >::size_type >(val2);
   (arg1)->resize(arg2);
@@ -20510,7 +20510,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::iterator arg2 ;
@@ -20524,18 +20524,18 @@ SWIGINTERN PyObject *_wrap_vector_string_t_erase__SWIG_0(PyObject *self, Py_ssiz
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_erase" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_erase" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t_erase" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T_erase" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::string >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::string >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t_erase" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T_erase" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
     }
   }
   result = std_vector_Sl_std_string_Sg__erase__SWIG_0(arg1,SWIG_STD_MOVE(arg2));
@@ -20547,7 +20547,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::iterator arg2 ;
@@ -20564,29 +20564,29 @@ SWIGINTERN PyObject *_wrap_vector_string_t_erase__SWIG_1(PyObject *self, Py_ssiz
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_erase" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_erase" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t_erase" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T_erase" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::string >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::string >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t_erase" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T_erase" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
     }
   }
   res3 = SWIG_ConvertPtr(swig_obj[2], SWIG_as_voidptrptr(&iter3), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res3) || !iter3) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t_erase" "', argument " "3"" of type '" "std::vector< std::string >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T_erase" "', argument " "3"" of type '" "std::vector< std::string >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::string >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::string >::iterator > *>(iter3);
     if (iter_t) {
       arg3 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t_erase" "', argument " "3"" of type '" "std::vector< std::string >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T_erase" "', argument " "3"" of type '" "std::vector< std::string >::iterator""'");
     }
   }
   result = std_vector_Sl_std_string_Sg__erase__SWIG_1(arg1,SWIG_STD_MOVE(arg2),SWIG_STD_MOVE(arg3));
@@ -20598,13 +20598,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_erase(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_erase(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_t_erase", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_T_erase", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -20615,7 +20615,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_erase(PyObject *self, PyObject *args)
       int res = SWIG_ConvertPtr(argv[1], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
       _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< std::string >::iterator > *>(iter) != 0));
       if (_v) {
-        return _wrap_vector_string_t_erase__SWIG_0(self, argc, argv);
+        return _wrap_vector_string_T_erase__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -20632,14 +20632,14 @@ SWIGINTERN PyObject *_wrap_vector_string_t_erase(PyObject *self, PyObject *args)
         int res = SWIG_ConvertPtr(argv[2], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
         _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< std::string >::iterator > *>(iter) != 0));
         if (_v) {
-          return _wrap_vector_string_t_erase__SWIG_1(self, argc, argv);
+          return _wrap_vector_string_T_erase__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_t_erase'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_T_erase'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::string >::erase(std::vector< std::string >::iterator)\n"
     "    std::vector< std::string >::erase(std::vector< std::string >::iterator,std::vector< std::string >::iterator)\n");
@@ -20647,7 +20647,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_string_t__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_string_T__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string >::size_type arg1 ;
   std::vector< std::string >::value_type *arg2 = 0 ;
@@ -20660,17 +20660,17 @@ SWIGINTERN PyObject *_wrap_new_vector_string_t__SWIG_3(PyObject *self, Py_ssize_
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_string_t" "', argument " "1"" of type '" "std::vector< std::string >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_string_T" "', argument " "1"" of type '" "std::vector< std::string >::size_type""'");
   } 
   arg1 = static_cast< std::vector< std::string >::size_type >(val1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "new_vector_string_t" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "new_vector_string_T" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_string_t" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_string_T" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -20684,16 +20684,16 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_string_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_new_vector_string_T(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vector_string_t", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vector_string_T", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 0) {
-    return _wrap_new_vector_string_t__SWIG_0(self, argc, argv);
+    return _wrap_new_vector_string_T__SWIG_0(self, argc, argv);
   }
   if (argc == 1) {
     int _v = 0;
@@ -20702,7 +20702,7 @@ SWIGINTERN PyObject *_wrap_new_vector_string_t(PyObject *self, PyObject *args) {
       _v = SWIG_CheckState(res);
     }
     if (_v) {
-      return _wrap_new_vector_string_t__SWIG_2(self, argc, argv);
+      return _wrap_new_vector_string_T__SWIG_2(self, argc, argv);
     }
   }
   if (argc == 1) {
@@ -20710,7 +20710,7 @@ SWIGINTERN PyObject *_wrap_new_vector_string_t(PyObject *self, PyObject *args) {
     int res = swig::asptr(argv[0], (std::vector< std::string,std::allocator< std::string > >**)(0));
     _v = SWIG_CheckState(res);
     if (_v) {
-      return _wrap_new_vector_string_t__SWIG_1(self, argc, argv);
+      return _wrap_new_vector_string_T__SWIG_1(self, argc, argv);
     }
   }
   if (argc == 2) {
@@ -20723,13 +20723,13 @@ SWIGINTERN PyObject *_wrap_new_vector_string_t(PyObject *self, PyObject *args) {
       int res = SWIG_AsPtr_std_string(argv[1], (std::string**)(0));
       _v = SWIG_CheckState(res);
       if (_v) {
-        return _wrap_new_vector_string_t__SWIG_3(self, argc, argv);
+        return _wrap_new_vector_string_T__SWIG_3(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vector_string_t'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vector_string_T'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::string >::vector()\n"
     "    std::vector< std::string >::vector(std::vector< std::string > const &)\n"
@@ -20739,7 +20739,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_push_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_push_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::value_type *arg2 = 0 ;
@@ -20749,20 +20749,20 @@ SWIGINTERN PyObject *_wrap_vector_string_t_push_back(PyObject *self, PyObject *a
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_string_t_push_back", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_string_T_push_back", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_push_back" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_push_back" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_string_t_push_back" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_string_T_push_back" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_t_push_back" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_T_push_back" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -20776,7 +20776,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_front(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_front(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -20789,7 +20789,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_front(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_front" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_front" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = (std::vector< std::string >::value_type *) &((std::vector< std::string > const *)arg1)->front();
@@ -20801,7 +20801,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -20814,7 +20814,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_back(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_back" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_back" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = (std::vector< std::string >::value_type *) &((std::vector< std::string > const *)arg1)->back();
@@ -20826,7 +20826,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_assign(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_assign(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::size_type arg2 ;
@@ -20839,25 +20839,25 @@ SWIGINTERN PyObject *_wrap_vector_string_t_assign(PyObject *self, PyObject *args
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_string_t_assign", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_string_T_assign", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_assign" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_assign" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_t_assign" "', argument " "2"" of type '" "std::vector< std::string >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_T_assign" "', argument " "2"" of type '" "std::vector< std::string >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::string >::size_type >(val2);
   {
     std::string *ptr = (std::string *)0;
     res3 = SWIG_AsPtr_std_string(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_string_t_assign" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_string_T_assign" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_t_assign" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_T_assign" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -20871,7 +20871,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::size_type arg2 ;
@@ -20886,22 +20886,22 @@ SWIGINTERN PyObject *_wrap_vector_string_t_resize__SWIG_1(PyObject *self, Py_ssi
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_resize" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_resize" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_t_resize" "', argument " "2"" of type '" "std::vector< std::string >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_T_resize" "', argument " "2"" of type '" "std::vector< std::string >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::string >::size_type >(val2);
   {
     std::string *ptr = (std::string *)0;
     res3 = SWIG_AsPtr_std_string(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_string_t_resize" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_string_T_resize" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_t_resize" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_T_resize" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -20915,13 +20915,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_resize(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_resize(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_t_resize", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_T_resize", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -20933,7 +20933,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_resize(PyObject *self, PyObject *args
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_string_t_resize__SWIG_0(self, argc, argv);
+        return _wrap_vector_string_T_resize__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -20950,14 +20950,14 @@ SWIGINTERN PyObject *_wrap_vector_string_t_resize(PyObject *self, PyObject *args
         int res = SWIG_AsPtr_std_string(argv[2], (std::string**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vector_string_t_resize__SWIG_1(self, argc, argv);
+          return _wrap_vector_string_T_resize__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_t_resize'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_T_resize'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::string >::resize(std::vector< std::string >::size_type)\n"
     "    std::vector< std::string >::resize(std::vector< std::string >::size_type,std::vector< std::string >::value_type const &)\n");
@@ -20965,7 +20965,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::iterator arg2 ;
@@ -20981,28 +20981,28 @@ SWIGINTERN PyObject *_wrap_vector_string_t_insert__SWIG_0(PyObject *self, Py_ssi
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_insert" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_insert" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t_insert" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T_insert" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::string >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::string >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t_insert" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T_insert" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
     }
   }
   {
     std::string *ptr = (std::string *)0;
     res3 = SWIG_AsPtr_std_string(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_string_t_insert" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_string_T_insert" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_t_insert" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_T_insert" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -21017,7 +21017,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::iterator arg2 ;
@@ -21035,33 +21035,33 @@ SWIGINTERN PyObject *_wrap_vector_string_t_insert__SWIG_1(PyObject *self, Py_ssi
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_insert" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_insert" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t_insert" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T_insert" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::string >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::string >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t_insert" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T_insert" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_size_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_string_t_insert" "', argument " "3"" of type '" "std::vector< std::string >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_string_T_insert" "', argument " "3"" of type '" "std::vector< std::string >::size_type""'");
   } 
   arg3 = static_cast< std::vector< std::string >::size_type >(val3);
   {
     std::string *ptr = (std::string *)0;
     res4 = SWIG_AsPtr_std_string(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_string_t_insert" "', argument " "4"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_string_T_insert" "', argument " "4"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_t_insert" "', argument " "4"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_T_insert" "', argument " "4"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     arg4 = ptr;
   }
@@ -21075,13 +21075,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_insert(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_insert(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_t_insert", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_T_insert", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -21095,7 +21095,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_insert(PyObject *self, PyObject *args
         int res = SWIG_AsPtr_std_string(argv[2], (std::string**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vector_string_t_insert__SWIG_0(self, argc, argv);
+          return _wrap_vector_string_T_insert__SWIG_0(self, argc, argv);
         }
       }
     }
@@ -21117,7 +21117,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_insert(PyObject *self, PyObject *args
           int res = SWIG_AsPtr_std_string(argv[3], (std::string**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vector_string_t_insert__SWIG_1(self, argc, argv);
+            return _wrap_vector_string_T_insert__SWIG_1(self, argc, argv);
           }
         }
       }
@@ -21125,7 +21125,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_insert(PyObject *self, PyObject *args
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_t_insert'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_T_insert'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::string >::insert(std::vector< std::string >::iterator,std::vector< std::string >::value_type const &)\n"
     "    std::vector< std::string >::insert(std::vector< std::string >::iterator,std::vector< std::string >::size_type,std::vector< std::string >::value_type const &)\n");
@@ -21133,7 +21133,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_reserve(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_reserve(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::size_type arg2 ;
@@ -21144,15 +21144,15 @@ SWIGINTERN PyObject *_wrap_vector_string_t_reserve(PyObject *self, PyObject *arg
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_string_t_reserve", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_string_T_reserve", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_reserve" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_reserve" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_t_reserve" "', argument " "2"" of type '" "std::vector< std::string >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_T_reserve" "', argument " "2"" of type '" "std::vector< std::string >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::string >::size_type >(val2);
   (arg1)->reserve(arg2);
@@ -21163,7 +21163,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_capacity(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_capacity(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -21176,7 +21176,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_capacity(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_capacity" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_capacity" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = ((std::vector< std::string > const *)arg1)->capacity();
@@ -21187,7 +21187,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_delete_vector_string_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_delete_vector_string_T(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -21199,7 +21199,7 @@ SWIGINTERN PyObject *_wrap_delete_vector_string_t(PyObject *self, PyObject *args
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, SWIG_POINTER_DISOWN |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vector_string_t" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vector_string_T" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   {
@@ -21220,18 +21220,18 @@ fail:
 }
 
 
-SWIGINTERN PyObject *vector_string_t_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vector_string_T_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   PyObject *obj;
   if (!SWIG_Python_UnpackTuple(args, "swigregister", 1, 1, &obj)) return NULL;
   SWIG_TypeNewClientData(SWIGTYPE_p_std__vectorT_std__string_t, SWIG_NewClientData(obj));
   return SWIG_Py_Void();
 }
 
-SWIGINTERN PyObject *vector_string_t_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vector_string_T_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   return SWIG_Python_InitShadowInstance(args);
 }
 
-SWIGINTERN PyObject *_wrap_new_map_string_double_t__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_map_string_double_T__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::less< std::string > *arg1 = 0 ;
   void *argp1 = 0 ;
@@ -21242,10 +21242,10 @@ SWIGINTERN PyObject *_wrap_new_map_string_double_t__SWIG_0(PyObject *self, Py_ss
   if ((nobjs < 1) || (nobjs > 1)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1, SWIGTYPE_p_std__lessT_std__string_t,  0  | 0);
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_map_string_double_t" "', argument " "1"" of type '" "std::less< std::string > const &""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_map_string_double_T" "', argument " "1"" of type '" "std::less< std::string > const &""'"); 
   }
   if (!argp1) {
-    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_map_string_double_t" "', argument " "1"" of type '" "std::less< std::string > const &""'"); 
+    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_map_string_double_T" "', argument " "1"" of type '" "std::less< std::string > const &""'"); 
   }
   arg1 = reinterpret_cast< std::less< std::string > * >(argp1);
   result = (std::map< std::string,double > *)new std::map< std::string,double >((std::less< std::string > const &)*arg1);
@@ -21256,7 +21256,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_iterator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_iterator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   PyObject **arg2 = (PyObject **) 0 ;
@@ -21271,7 +21271,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_iterator(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_iterator" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_iterator" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (swig::SwigPyIterator *)std_map_Sl_std_string_Sc_double_Sg__iterator(arg1,arg2);
@@ -21282,7 +21282,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t___nonzero__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T___nonzero__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -21295,7 +21295,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t___nonzero__(PyObject *self, PyObj
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t___nonzero__" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T___nonzero__" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (bool)std_map_Sl_std_string_Sc_double_Sg____nonzero__((std::map< std::string,double > const *)arg1);
@@ -21306,7 +21306,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t___bool__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T___bool__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -21319,7 +21319,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t___bool__(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t___bool__" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T___bool__" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (bool)std_map_Sl_std_string_Sc_double_Sg____bool__((std::map< std::string,double > const *)arg1);
@@ -21330,7 +21330,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t___len__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T___len__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -21343,7 +21343,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t___len__(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t___len__" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T___len__" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = std_map_Sl_std_string_Sc_double_Sg____len__((std::map< std::string,double > const *)arg1);
@@ -21354,7 +21354,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t___getitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T___getitem__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::key_type *arg2 = 0 ;
@@ -21365,20 +21365,20 @@ SWIGINTERN PyObject *_wrap_map_string_double_t___getitem__(PyObject *self, PyObj
   std::map< std::string,double >::mapped_type *result = 0 ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "map_string_double_t___getitem__", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "map_string_double_T___getitem__", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t___getitem__" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T___getitem__" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t___getitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T___getitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t___getitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T___getitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -21396,7 +21396,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t___delitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T___delitem__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::key_type *arg2 = 0 ;
@@ -21406,20 +21406,20 @@ SWIGINTERN PyObject *_wrap_map_string_double_t___delitem__(PyObject *self, PyObj
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "map_string_double_t___delitem__", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "map_string_double_T___delitem__", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t___delitem__" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T___delitem__" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t___delitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T___delitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t___delitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T___delitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -21437,7 +21437,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_has_key(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_has_key(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::key_type *arg2 = 0 ;
@@ -21448,20 +21448,20 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_has_key(PyObject *self, PyObject
   bool result;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "map_string_double_t_has_key", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "map_string_double_T_has_key", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_has_key" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_has_key" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t_has_key" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T_has_key" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t_has_key" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T_has_key" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -21475,7 +21475,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_keys(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_keys(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -21488,7 +21488,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_keys(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_keys" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_keys" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (PyObject *)std_map_Sl_std_string_Sc_double_Sg__keys(arg1);
@@ -21499,7 +21499,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_values(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_values(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -21512,7 +21512,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_values(PyObject *self, PyObject *
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_values" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_values" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (PyObject *)std_map_Sl_std_string_Sc_double_Sg__values(arg1);
@@ -21523,7 +21523,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_items(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_items(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -21536,7 +21536,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_items(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_items" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_items" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (PyObject *)std_map_Sl_std_string_Sc_double_Sg__items(arg1);
@@ -21547,7 +21547,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t___contains__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T___contains__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::key_type *arg2 = 0 ;
@@ -21558,20 +21558,20 @@ SWIGINTERN PyObject *_wrap_map_string_double_t___contains__(PyObject *self, PyOb
   bool result;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "map_string_double_t___contains__", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "map_string_double_T___contains__", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t___contains__" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T___contains__" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t___contains__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T___contains__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t___contains__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T___contains__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -21585,7 +21585,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_key_iterator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_key_iterator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   PyObject **arg2 = (PyObject **) 0 ;
@@ -21600,7 +21600,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_key_iterator(PyObject *self, PyOb
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_key_iterator" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_key_iterator" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (swig::SwigPyIterator *)std_map_Sl_std_string_Sc_double_Sg__key_iterator(arg1,arg2);
@@ -21611,7 +21611,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_value_iterator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_value_iterator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   PyObject **arg2 = (PyObject **) 0 ;
@@ -21626,7 +21626,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_value_iterator(PyObject *self, Py
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_value_iterator" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_value_iterator" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (swig::SwigPyIterator *)std_map_Sl_std_string_Sc_double_Sg__value_iterator(arg1,arg2);
@@ -21637,7 +21637,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_map_string_double_T___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::key_type *arg2 = 0 ;
@@ -21649,17 +21649,17 @@ SWIGINTERN PyObject *_wrap_map_string_double_t___setitem____SWIG_0(PyObject *sel
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t___setitem__" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T___setitem__" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t___setitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T___setitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t___setitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T___setitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -21673,7 +21673,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_map_string_double_T___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::key_type *arg2 = 0 ;
@@ -21689,23 +21689,23 @@ SWIGINTERN PyObject *_wrap_map_string_double_t___setitem____SWIG_1(PyObject *sel
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t___setitem__" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T___setitem__" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t___setitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T___setitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t___setitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T___setitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     arg2 = ptr;
   }
   ecode3 = SWIG_AsVal_double(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "map_string_double_t___setitem__" "', argument " "3"" of type '" "std::map< std::string,double >::mapped_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "map_string_double_T___setitem__" "', argument " "3"" of type '" "std::map< std::string,double >::mapped_type""'");
   } 
   temp3 = static_cast< std::map< std::string,double >::mapped_type >(val3);
   arg3 = &temp3;
@@ -21723,13 +21723,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t___setitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T___setitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "map_string_double_t___setitem__", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "map_string_double_T___setitem__", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -21739,7 +21739,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t___setitem__(PyObject *self, PyObj
       int res = SWIG_AsPtr_std_string(argv[1], (std::string**)(0));
       _v = SWIG_CheckState(res);
       if (_v) {
-        return _wrap_map_string_double_t___setitem____SWIG_0(self, argc, argv);
+        return _wrap_map_string_double_T___setitem____SWIG_0(self, argc, argv);
       }
     }
   }
@@ -21756,14 +21756,14 @@ SWIGINTERN PyObject *_wrap_map_string_double_t___setitem__(PyObject *self, PyObj
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_map_string_double_t___setitem____SWIG_1(self, argc, argv);
+          return _wrap_map_string_double_T___setitem____SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'map_string_double_t___setitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'map_string_double_T___setitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::map< std::string,double >::__setitem__(std::map< std::string,double >::key_type const &)\n"
     "    std::map< std::string,double >::__setitem__(std::map< std::string,double >::key_type const &,std::map< std::string,double >::mapped_type const &)\n");
@@ -21771,7 +21771,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_asdict(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_asdict(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -21784,7 +21784,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_asdict(PyObject *self, PyObject *
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_asdict" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_asdict" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (PyObject *)std_map_Sl_std_string_Sc_double_Sg__asdict(arg1);
@@ -21795,7 +21795,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_map_string_double_t__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
+SWIGINTERN PyObject *_wrap_new_map_string_double_T__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *result = 0 ;
   
@@ -21809,7 +21809,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_map_string_double_t__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_map_string_double_T__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = 0 ;
   int res1 = SWIG_OLDOBJ ;
@@ -21821,10 +21821,10 @@ SWIGINTERN PyObject *_wrap_new_map_string_double_t__SWIG_2(PyObject *self, Py_ss
     std::map< std::string,double,std::less< std::string >,std::allocator< std::pair< std::string const,double > > > *ptr = (std::map< std::string,double,std::less< std::string >,std::allocator< std::pair< std::string const,double > > > *)0;
     res1 = swig::asptr(swig_obj[0], &ptr);
     if (!SWIG_IsOK(res1)) {
-      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_map_string_double_t" "', argument " "1"" of type '" "std::map< std::string,double > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_map_string_double_T" "', argument " "1"" of type '" "std::map< std::string,double > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_map_string_double_t" "', argument " "1"" of type '" "std::map< std::string,double > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_map_string_double_T" "', argument " "1"" of type '" "std::map< std::string,double > const &""'"); 
     }
     arg1 = ptr;
   }
@@ -21838,23 +21838,23 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_map_string_double_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_new_map_string_double_T(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[2] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "new_map_string_double_t", 0, 1, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "new_map_string_double_T", 0, 1, argv))) SWIG_fail;
   --argc;
   if (argc == 0) {
-    return _wrap_new_map_string_double_t__SWIG_1(self, argc, argv);
+    return _wrap_new_map_string_double_T__SWIG_1(self, argc, argv);
   }
   if (argc == 1) {
     int _v = 0;
     int res = SWIG_ConvertPtr(argv[0], 0, SWIGTYPE_p_std__lessT_std__string_t, SWIG_POINTER_NO_NULL | 0);
     _v = SWIG_CheckState(res);
     if (_v) {
-      return _wrap_new_map_string_double_t__SWIG_0(self, argc, argv);
+      return _wrap_new_map_string_double_T__SWIG_0(self, argc, argv);
     }
   }
   if (argc == 1) {
@@ -21862,12 +21862,12 @@ SWIGINTERN PyObject *_wrap_new_map_string_double_t(PyObject *self, PyObject *arg
     int res = swig::asptr(argv[0], (std::map< std::string,double,std::less< std::string >,std::allocator< std::pair< std::string const,double > > >**)(0));
     _v = SWIG_CheckState(res);
     if (_v) {
-      return _wrap_new_map_string_double_t__SWIG_2(self, argc, argv);
+      return _wrap_new_map_string_double_T__SWIG_2(self, argc, argv);
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_map_string_double_t'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_map_string_double_T'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::map< std::string,double >::map(std::less< std::string > const &)\n"
     "    std::map< std::string,double >::map()\n"
@@ -21876,7 +21876,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_empty(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_empty(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -21889,7 +21889,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_empty(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_empty" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_empty" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (bool)((std::map< std::string,double > const *)arg1)->empty();
@@ -21900,7 +21900,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_size(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_size(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -21913,7 +21913,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_size(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_size" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_size" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = ((std::map< std::string,double > const *)arg1)->size();
@@ -21924,7 +21924,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_swap(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_swap(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double > *arg2 = 0 ;
@@ -21935,18 +21935,18 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_swap(PyObject *self, PyObject *ar
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "map_string_double_t_swap", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "map_string_double_T_swap", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_swap" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_swap" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], &argp2, SWIGTYPE_p_std__mapT_std__string_double_t,  0 );
   if (!SWIG_IsOK(res2)) {
-    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t_swap" "', argument " "2"" of type '" "std::map< std::string,double > &""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T_swap" "', argument " "2"" of type '" "std::map< std::string,double > &""'"); 
   }
   if (!argp2) {
-    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t_swap" "', argument " "2"" of type '" "std::map< std::string,double > &""'"); 
+    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T_swap" "', argument " "2"" of type '" "std::map< std::string,double > &""'"); 
   }
   arg2 = reinterpret_cast< std::map< std::string,double > * >(argp2);
   (arg1)->swap(*arg2);
@@ -21957,7 +21957,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_begin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_begin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -21970,7 +21970,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_begin(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_begin" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_begin" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (arg1)->begin();
@@ -21982,7 +21982,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_end(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_end(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -21995,7 +21995,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_end(PyObject *self, PyObject *arg
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_end" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_end" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (arg1)->end();
@@ -22007,7 +22007,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_rbegin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_rbegin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -22020,7 +22020,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_rbegin(PyObject *self, PyObject *
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_rbegin" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_rbegin" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (arg1)->rbegin();
@@ -22032,7 +22032,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_rend(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_rend(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -22045,7 +22045,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_rend(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_rend" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_rend" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (arg1)->rend();
@@ -22057,7 +22057,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_clear(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_clear(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -22069,7 +22069,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_clear(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_clear" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_clear" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   (arg1)->clear();
@@ -22080,7 +22080,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_get_allocator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_get_allocator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -22093,7 +22093,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_get_allocator(PyObject *self, PyO
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_get_allocator" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_get_allocator" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = ((std::map< std::string,double > const *)arg1)->get_allocator();
@@ -22104,7 +22104,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::key_type *arg2 = 0 ;
@@ -22117,17 +22117,17 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_erase__SWIG_0(PyObject *self, Py_
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_erase" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_erase" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t_erase" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T_erase" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t_erase" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T_erase" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -22141,7 +22141,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_count(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_count(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::key_type *arg2 = 0 ;
@@ -22152,20 +22152,20 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_count(PyObject *self, PyObject *a
   std::map< std::string,double >::size_type result;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "map_string_double_t_count", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "map_string_double_T_count", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_count" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_count" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t_count" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T_count" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t_count" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T_count" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -22179,7 +22179,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::iterator arg2 ;
@@ -22192,18 +22192,18 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_erase__SWIG_1(PyObject *self, Py_
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_erase" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_erase" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_t_erase" "', argument " "2"" of type '" "std::map< std::string,double >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_T_erase" "', argument " "2"" of type '" "std::map< std::string,double >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::map< std::string,double >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::map< std::string,double >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_t_erase" "', argument " "2"" of type '" "std::map< std::string,double >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_T_erase" "', argument " "2"" of type '" "std::map< std::string,double >::iterator""'");
     }
   }
   std_map_Sl_std_string_Sc_double_Sg__erase__SWIG_1(arg1,SWIG_STD_MOVE(arg2));
@@ -22214,7 +22214,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_erase__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_erase__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::iterator arg2 ;
@@ -22230,29 +22230,29 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_erase__SWIG_2(PyObject *self, Py_
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_erase" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_erase" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_t_erase" "', argument " "2"" of type '" "std::map< std::string,double >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_T_erase" "', argument " "2"" of type '" "std::map< std::string,double >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::map< std::string,double >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::map< std::string,double >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_t_erase" "', argument " "2"" of type '" "std::map< std::string,double >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_T_erase" "', argument " "2"" of type '" "std::map< std::string,double >::iterator""'");
     }
   }
   res3 = SWIG_ConvertPtr(swig_obj[2], SWIG_as_voidptrptr(&iter3), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res3) || !iter3) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_t_erase" "', argument " "3"" of type '" "std::map< std::string,double >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_T_erase" "', argument " "3"" of type '" "std::map< std::string,double >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::map< std::string,double >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::map< std::string,double >::iterator > *>(iter3);
     if (iter_t) {
       arg3 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_t_erase" "', argument " "3"" of type '" "std::map< std::string,double >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_T_erase" "', argument " "3"" of type '" "std::map< std::string,double >::iterator""'");
     }
   }
   std_map_Sl_std_string_Sc_double_Sg__erase__SWIG_2(arg1,SWIG_STD_MOVE(arg2),SWIG_STD_MOVE(arg3));
@@ -22263,13 +22263,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_erase(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_erase(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "map_string_double_t_erase", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "map_string_double_T_erase", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -22280,7 +22280,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_erase(PyObject *self, PyObject *a
       int res = SWIG_ConvertPtr(argv[1], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
       _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::map< std::string,double >::iterator > *>(iter) != 0));
       if (_v) {
-        return _wrap_map_string_double_t_erase__SWIG_1(self, argc, argv);
+        return _wrap_map_string_double_T_erase__SWIG_1(self, argc, argv);
       }
     }
   }
@@ -22292,7 +22292,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_erase(PyObject *self, PyObject *a
       int res = SWIG_AsPtr_std_string(argv[1], (std::string**)(0));
       _v = SWIG_CheckState(res);
       if (_v) {
-        return _wrap_map_string_double_t_erase__SWIG_0(self, argc, argv);
+        return _wrap_map_string_double_T_erase__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -22309,14 +22309,14 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_erase(PyObject *self, PyObject *a
         int res = SWIG_ConvertPtr(argv[2], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
         _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::map< std::string,double >::iterator > *>(iter) != 0));
         if (_v) {
-          return _wrap_map_string_double_t_erase__SWIG_2(self, argc, argv);
+          return _wrap_map_string_double_T_erase__SWIG_2(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'map_string_double_t_erase'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'map_string_double_T_erase'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::map< std::string,double >::erase(std::map< std::string,double >::key_type const &)\n"
     "    std::map< std::string,double >::erase(std::map< std::string,double >::iterator)\n"
@@ -22325,7 +22325,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_find(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_find(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::key_type *arg2 = 0 ;
@@ -22336,20 +22336,20 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_find(PyObject *self, PyObject *ar
   std::map< std::string,double >::iterator result;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "map_string_double_t_find", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "map_string_double_T_find", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_find" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_find" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t_find" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T_find" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t_find" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T_find" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -22364,7 +22364,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_lower_bound(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_lower_bound(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::key_type *arg2 = 0 ;
@@ -22375,20 +22375,20 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_lower_bound(PyObject *self, PyObj
   std::map< std::string,double >::iterator result;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "map_string_double_t_lower_bound", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "map_string_double_T_lower_bound", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_lower_bound" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_lower_bound" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t_lower_bound" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T_lower_bound" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t_lower_bound" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T_lower_bound" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -22403,7 +22403,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_upper_bound(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_upper_bound(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::key_type *arg2 = 0 ;
@@ -22414,20 +22414,20 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_upper_bound(PyObject *self, PyObj
   std::map< std::string,double >::iterator result;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "map_string_double_t_upper_bound", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "map_string_double_T_upper_bound", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_upper_bound" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_upper_bound" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t_upper_bound" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T_upper_bound" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t_upper_bound" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T_upper_bound" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -22442,7 +22442,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_delete_map_string_double_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_delete_map_string_double_T(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -22454,7 +22454,7 @@ SWIGINTERN PyObject *_wrap_delete_map_string_double_t(PyObject *self, PyObject *
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, SWIG_POINTER_DISOWN |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_map_string_double_t" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_map_string_double_T" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
@@ -22475,18 +22475,18 @@ fail:
 }
 
 
-SWIGINTERN PyObject *map_string_double_t_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *map_string_double_T_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   PyObject *obj;
   if (!SWIG_Python_UnpackTuple(args, "swigregister", 1, 1, &obj)) return NULL;
   SWIG_TypeNewClientData(SWIGTYPE_p_std__mapT_std__string_double_t, SWIG_NewClientData(obj));
   return SWIG_Py_Void();
 }
 
-SWIGINTERN PyObject *map_string_double_t_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *map_string_double_T_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   return SWIG_Python_InitShadowInstance(args);
 }
 
-SWIGINTERN PyObject *_wrap_new_pvacuum_double_t__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
+SWIGINTERN PyObject *_wrap_new_pvacuum_double_T__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
   PyObject *resultobj = 0;
   std::pair< double,double > *result = 0 ;
   
@@ -22500,7 +22500,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_pvacuum_double_t__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_pvacuum_double_T__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   double arg1 ;
   double arg2 ;
@@ -22514,12 +22514,12 @@ SWIGINTERN PyObject *_wrap_new_pvacuum_double_t__SWIG_1(PyObject *self, Py_ssize
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   ecode1 = SWIG_AsVal_double(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_pvacuum_double_t" "', argument " "1"" of type '" "double""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_pvacuum_double_T" "', argument " "1"" of type '" "double""'");
   } 
   arg1 = static_cast< double >(val1);
   ecode2 = SWIG_AsVal_double(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "new_pvacuum_double_t" "', argument " "2"" of type '" "double""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "new_pvacuum_double_T" "', argument " "2"" of type '" "double""'");
   } 
   arg2 = static_cast< double >(val2);
   result = (std::pair< double,double > *)new std::pair< double,double >(arg1,arg2);
@@ -22530,7 +22530,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_pvacuum_double_t__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_pvacuum_double_T__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::pair< double,double > *arg1 = 0 ;
   int res1 = SWIG_OLDOBJ ;
@@ -22542,10 +22542,10 @@ SWIGINTERN PyObject *_wrap_new_pvacuum_double_t__SWIG_2(PyObject *self, Py_ssize
     std::pair< double,double > *ptr = (std::pair< double,double > *)0;
     res1 = swig::asptr(swig_obj[0], &ptr);
     if (!SWIG_IsOK(res1)) {
-      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_pvacuum_double_t" "', argument " "1"" of type '" "std::pair< double,double > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_pvacuum_double_T" "', argument " "1"" of type '" "std::pair< double,double > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_pvacuum_double_t" "', argument " "1"" of type '" "std::pair< double,double > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_pvacuum_double_T" "', argument " "1"" of type '" "std::pair< double,double > const &""'"); 
     }
     arg1 = ptr;
   }
@@ -22559,23 +22559,23 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_pvacuum_double_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_new_pvacuum_double_T(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "new_pvacuum_double_t", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "new_pvacuum_double_T", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 0) {
-    return _wrap_new_pvacuum_double_t__SWIG_0(self, argc, argv);
+    return _wrap_new_pvacuum_double_T__SWIG_0(self, argc, argv);
   }
   if (argc == 1) {
     int _v = 0;
     int res = swig::asptr(argv[0], (std::pair< double,double >**)(0));
     _v = SWIG_CheckState(res);
     if (_v) {
-      return _wrap_new_pvacuum_double_t__SWIG_2(self, argc, argv);
+      return _wrap_new_pvacuum_double_T__SWIG_2(self, argc, argv);
     }
   }
   if (argc == 2) {
@@ -22590,13 +22590,13 @@ SWIGINTERN PyObject *_wrap_new_pvacuum_double_t(PyObject *self, PyObject *args)
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_new_pvacuum_double_t__SWIG_1(self, argc, argv);
+        return _wrap_new_pvacuum_double_T__SWIG_1(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_pvacuum_double_t'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_pvacuum_double_T'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::pair< double,double >::pair()\n"
     "    std::pair< double,double >::pair(double,double)\n"
@@ -22605,7 +22605,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_pvacuum_double_t_first_set(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_pvacuum_double_T_first_set(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::pair< double,double > *arg1 = (std::pair< double,double > *) 0 ;
   double arg2 ;
@@ -22616,15 +22616,15 @@ SWIGINTERN PyObject *_wrap_pvacuum_double_t_first_set(PyObject *self, PyObject *
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "pvacuum_double_t_first_set", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "pvacuum_double_T_first_set", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__pairT_double_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "pvacuum_double_t_first_set" "', argument " "1"" of type '" "std::pair< double,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "pvacuum_double_T_first_set" "', argument " "1"" of type '" "std::pair< double,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::pair< double,double > * >(argp1);
   ecode2 = SWIG_AsVal_double(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "pvacuum_double_t_first_set" "', argument " "2"" of type '" "double""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "pvacuum_double_T_first_set" "', argument " "2"" of type '" "double""'");
   } 
   arg2 = static_cast< double >(val2);
   if (arg1) (arg1)->first = arg2;
@@ -22635,7 +22635,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_pvacuum_double_t_first_get(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_pvacuum_double_T_first_get(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::pair< double,double > *arg1 = (std::pair< double,double > *) 0 ;
   void *argp1 = 0 ;
@@ -22648,7 +22648,7 @@ SWIGINTERN PyObject *_wrap_pvacuum_double_t_first_get(PyObject *self, PyObject *
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__pairT_double_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "pvacuum_double_t_first_get" "', argument " "1"" of type '" "std::pair< double,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "pvacuum_double_T_first_get" "', argument " "1"" of type '" "std::pair< double,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::pair< double,double > * >(argp1);
   result = (double) ((arg1)->first);
@@ -22659,7 +22659,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_pvacuum_double_t_second_set(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_pvacuum_double_T_second_set(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::pair< double,double > *arg1 = (std::pair< double,double > *) 0 ;
   double arg2 ;
@@ -22670,15 +22670,15 @@ SWIGINTERN PyObject *_wrap_pvacuum_double_t_second_set(PyObject *self, PyObject
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "pvacuum_double_t_second_set", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "pvacuum_double_T_second_set", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__pairT_double_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "pvacuum_double_t_second_set" "', argument " "1"" of type '" "std::pair< double,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "pvacuum_double_T_second_set" "', argument " "1"" of type '" "std::pair< double,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::pair< double,double > * >(argp1);
   ecode2 = SWIG_AsVal_double(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "pvacuum_double_t_second_set" "', argument " "2"" of type '" "double""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "pvacuum_double_T_second_set" "', argument " "2"" of type '" "double""'");
   } 
   arg2 = static_cast< double >(val2);
   if (arg1) (arg1)->second = arg2;
@@ -22689,7 +22689,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_pvacuum_double_t_second_get(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_pvacuum_double_T_second_get(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::pair< double,double > *arg1 = (std::pair< double,double > *) 0 ;
   void *argp1 = 0 ;
@@ -22702,7 +22702,7 @@ SWIGINTERN PyObject *_wrap_pvacuum_double_t_second_get(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__pairT_double_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "pvacuum_double_t_second_get" "', argument " "1"" of type '" "std::pair< double,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "pvacuum_double_T_second_get" "', argument " "1"" of type '" "std::pair< double,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::pair< double,double > * >(argp1);
   result = (double) ((arg1)->second);
@@ -22713,7 +22713,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_delete_pvacuum_double_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_delete_pvacuum_double_T(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::pair< double,double > *arg1 = (std::pair< double,double > *) 0 ;
   void *argp1 = 0 ;
@@ -22725,7 +22725,7 @@ SWIGINTERN PyObject *_wrap_delete_pvacuum_double_t(PyObject *self, PyObject *arg
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__pairT_double_double_t, SWIG_POINTER_DISOWN |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_pvacuum_double_t" "', argument " "1"" of type '" "std::pair< double,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_pvacuum_double_T" "', argument " "1"" of type '" "std::pair< double,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::pair< double,double > * >(argp1);
   {
@@ -22746,18 +22746,18 @@ fail:
 }
 
 
-SWIGINTERN PyObject *pvacuum_double_t_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *pvacuum_double_T_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   PyObject *obj;
   if (!SWIG_Python_UnpackTuple(args, "swigregister", 1, 1, &obj)) return NULL;
   SWIG_TypeNewClientData(SWIGTYPE_p_std__pairT_double_double_t, SWIG_NewClientData(obj));
   return SWIG_Py_Void();
 }
 
-SWIGINTERN PyObject *pvacuum_double_t_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *pvacuum_double_T_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   return SWIG_Python_InitShadowInstance(args);
 }
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_iterator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_iterator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   PyObject **arg2 = (PyObject **) 0 ;
@@ -22772,7 +22772,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_iterator(PyObject *self, PyOb
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_iterator" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_iterator" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = (swig::SwigPyIterator *)std_vector_Sl_std_pair_Sl_double_Sc_double_Sg__Sg__iterator(arg1,arg2);
@@ -22783,7 +22783,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___nonzero__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___nonzero__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -22796,7 +22796,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___nonzero__(PyObject *self, P
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___nonzero__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___nonzero__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = (bool)std_vector_Sl_std_pair_Sl_double_Sc_double_Sg__Sg____nonzero__((std::vector< std::pair< double,double > > const *)arg1);
@@ -22807,7 +22807,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___bool__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___bool__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -22820,7 +22820,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___bool__(PyObject *self, PyOb
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___bool__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___bool__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = (bool)std_vector_Sl_std_pair_Sl_double_Sc_double_Sg__Sg____bool__((std::vector< std::pair< double,double > > const *)arg1);
@@ -22831,7 +22831,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___len__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___len__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -22844,7 +22844,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___len__(PyObject *self, PyObj
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___len__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___len__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = std_vector_Sl_std_pair_Sl_double_Sc_double_Sg__Sg____len__((std::vector< std::pair< double,double > > const *)arg1);
@@ -22855,7 +22855,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___getslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___getslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::difference_type arg2 ;
@@ -22870,20 +22870,20 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___getslice__(PyObject *self,
   std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > *result = 0 ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t___getslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T___getslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___getslice__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___getslice__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_t___getslice__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_T___getslice__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::pair< double,double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_pvacuum_double_t___getslice__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_pvacuum_double_T___getslice__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::pair< double,double > >::difference_type >(val3);
   try {
@@ -22900,7 +22900,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::difference_type arg2 ;
@@ -22916,17 +22916,17 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setslice____SWIG_0(PyObject
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___setslice__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___setslice__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_t___setslice__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_T___setslice__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::pair< double,double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_pvacuum_double_t___setslice__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_pvacuum_double_T___setslice__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::pair< double,double > >::difference_type >(val3);
   try {
@@ -22943,7 +22943,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::difference_type arg2 ;
@@ -22961,27 +22961,27 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setslice____SWIG_1(PyObject
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___setslice__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___setslice__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_t___setslice__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_T___setslice__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::pair< double,double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_pvacuum_double_t___setslice__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_pvacuum_double_T___setslice__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::pair< double,double > >::difference_type >(val3);
   {
     std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > *ptr = (std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > *)0;
     res4 = swig::asptr(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_pvacuum_double_t___setslice__" "', argument " "4"" of type '" "std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_pvacuum_double_T___setslice__" "', argument " "4"" of type '" "std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_t___setslice__" "', argument " "4"" of type '" "std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_T___setslice__" "', argument " "4"" of type '" "std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > const &""'"); 
     }
     arg4 = ptr;
   }
@@ -23001,13 +23001,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___setslice__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t___setslice__", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T___setslice__", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -23024,7 +23024,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setslice__(PyObject *self,
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_pvacuum_double_t___setslice____SWIG_0(self, argc, argv);
+          return _wrap_vector_pvacuum_double_T___setslice____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -23047,7 +23047,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setslice__(PyObject *self,
           int res = swig::asptr(argv[3], (std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > >**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vector_pvacuum_double_t___setslice____SWIG_1(self, argc, argv);
+            return _wrap_vector_pvacuum_double_T___setslice____SWIG_1(self, argc, argv);
           }
         }
       }
@@ -23055,7 +23055,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setslice__(PyObject *self,
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_t___setslice__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_T___setslice__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::pair< double,double > >::__setslice__(std::vector< std::pair< double,double > >::difference_type,std::vector< std::pair< double,double > >::difference_type)\n"
     "    std::vector< std::pair< double,double > >::__setslice__(std::vector< std::pair< double,double > >::difference_type,std::vector< std::pair< double,double > >::difference_type,std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > const &)\n");
@@ -23063,7 +23063,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___delslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___delslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::difference_type arg2 ;
@@ -23077,20 +23077,20 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___delslice__(PyObject *self,
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t___delslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T___delslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___delslice__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___delslice__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_t___delslice__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_T___delslice__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::pair< double,double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_pvacuum_double_t___delslice__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_pvacuum_double_T___delslice__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::pair< double,double > >::difference_type >(val3);
   try {
@@ -23107,7 +23107,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::difference_type arg2 ;
@@ -23120,12 +23120,12 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___delitem____SWIG_0(PyObject
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___delitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___delitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_t___delitem__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_T___delitem__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::pair< double,double > >::difference_type >(val2);
   try {
@@ -23142,7 +23142,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -23154,12 +23154,12 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___getitem____SWIG_0(PyObject
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___getitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___getitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -23177,7 +23177,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -23190,12 +23190,12 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setitem____SWIG_0(PyObject
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___setitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___setitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -23203,10 +23203,10 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setitem____SWIG_0(PyObject
     std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > *ptr = (std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_pvacuum_double_t___setitem__" "', argument " "3"" of type '" "std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_pvacuum_double_T___setitem__" "', argument " "3"" of type '" "std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_t___setitem__" "', argument " "3"" of type '" "std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_T___setitem__" "', argument " "3"" of type '" "std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > const &""'"); 
     }
     arg3 = ptr;
   }
@@ -23226,7 +23226,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -23237,12 +23237,12 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setitem____SWIG_1(PyObject
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___setitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___setitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -23260,7 +23260,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -23271,12 +23271,12 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___delitem____SWIG_1(PyObject
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___delitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___delitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -23294,13 +23294,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___delitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___delitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t___delitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T___delitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -23311,7 +23311,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___delitem__(PyObject *self, P
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_pvacuum_double_t___delitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_pvacuum_double_T___delitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -23325,13 +23325,13 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___delitem__(PyObject *self, P
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_pvacuum_double_t___delitem____SWIG_0(self, argc, argv);
+        return _wrap_vector_pvacuum_double_T___delitem____SWIG_0(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_t___delitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_T___delitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::pair< double,double > >::__delitem__(std::vector< std::pair< double,double > >::difference_type)\n"
     "    std::vector< std::pair< double,double > >::__delitem__(SWIGPY_SLICEOBJECT *)\n");
@@ -23339,7 +23339,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::difference_type arg2 ;
@@ -23353,12 +23353,12 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___getitem____SWIG_1(PyObject
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___getitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___getitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_t___getitem__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_T___getitem__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::pair< double,double > >::difference_type >(val2);
   try {
@@ -23374,13 +23374,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___getitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___getitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t___getitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T___getitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -23391,7 +23391,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___getitem__(PyObject *self, P
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_pvacuum_double_t___getitem____SWIG_0(self, argc, argv);
+        return _wrap_vector_pvacuum_double_T___getitem____SWIG_0(self, argc, argv);
       }
     }
   }
@@ -23405,13 +23405,13 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___getitem__(PyObject *self, P
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_pvacuum_double_t___getitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_pvacuum_double_T___getitem____SWIG_1(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_t___getitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_T___getitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::pair< double,double > >::__getitem__(SWIGPY_SLICEOBJECT *)\n"
     "    std::vector< std::pair< double,double > >::__getitem__(std::vector< std::pair< double,double > >::difference_type) const\n");
@@ -23419,7 +23419,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::difference_type arg2 ;
@@ -23434,22 +23434,22 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setitem____SWIG_2(PyObject
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___setitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___setitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_t___setitem__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_T___setitem__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::pair< double,double > >::difference_type >(val2);
   {
     std::pair< double,double > *ptr = (std::pair< double,double > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_pvacuum_double_t___setitem__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_pvacuum_double_T___setitem__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_t___setitem__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_T___setitem__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -23467,13 +23467,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___setitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t___setitem__", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T___setitem__", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -23484,7 +23484,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setitem__(PyObject *self, P
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_pvacuum_double_t___setitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_pvacuum_double_T___setitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -23500,7 +23500,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setitem__(PyObject *self, P
         int res = swig::asptr(argv[2], (std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vector_pvacuum_double_t___setitem____SWIG_0(self, argc, argv);
+          return _wrap_vector_pvacuum_double_T___setitem____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -23518,14 +23518,14 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setitem__(PyObject *self, P
         int res = swig::asptr(argv[2], (std::pair< double,double >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vector_pvacuum_double_t___setitem____SWIG_2(self, argc, argv);
+          return _wrap_vector_pvacuum_double_T___setitem____SWIG_2(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_t___setitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_T___setitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::pair< double,double > >::__setitem__(SWIGPY_SLICEOBJECT *,std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > const &)\n"
     "    std::vector< std::pair< double,double > >::__setitem__(SWIGPY_SLICEOBJECT *)\n"
@@ -23534,7 +23534,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_pop(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_pop(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -23547,7 +23547,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_pop(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_pop" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_pop" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   try {
@@ -23562,7 +23562,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_append(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_append(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::value_type *arg2 = 0 ;
@@ -23572,20 +23572,20 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_append(PyObject *self, PyObje
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t_append", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T_append", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_append" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_append" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   {
     std::pair< double,double > *ptr = (std::pair< double,double > *)0;
     res2 = swig::asptr(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_pvacuum_double_t_append" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_pvacuum_double_T_append" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_t_append" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_T_append" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -23599,7 +23599,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_t__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
+SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_T__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *result = 0 ;
   
@@ -23613,7 +23613,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_t__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_T__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = 0 ;
   int res1 = SWIG_OLDOBJ ;
@@ -23625,10 +23625,10 @@ SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_t__SWIG_1(PyObject *self, P
     std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > *ptr = (std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > *)0;
     res1 = swig::asptr(swig_obj[0], &ptr);
     if (!SWIG_IsOK(res1)) {
-      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vector_pvacuum_double_t" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vector_pvacuum_double_T" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_pvacuum_double_t" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_pvacuum_double_T" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const &""'"); 
     }
     arg1 = ptr;
   }
@@ -23642,7 +23642,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_empty(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_empty(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -23655,7 +23655,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_empty(PyObject *self, PyObjec
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_empty" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_empty" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = (bool)((std::vector< std::pair< double,double > > const *)arg1)->empty();
@@ -23666,7 +23666,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_size(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_size(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -23679,7 +23679,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_size(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_size" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_size" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = ((std::vector< std::pair< double,double > > const *)arg1)->size();
@@ -23690,7 +23690,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_swap(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_swap(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > > *arg2 = 0 ;
@@ -23701,18 +23701,18 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_swap(PyObject *self, PyObject
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t_swap", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T_swap", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_swap" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_swap" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], &argp2, SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t,  0 );
   if (!SWIG_IsOK(res2)) {
-    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_pvacuum_double_t_swap" "', argument " "2"" of type '" "std::vector< std::pair< double,double > > &""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_pvacuum_double_T_swap" "', argument " "2"" of type '" "std::vector< std::pair< double,double > > &""'"); 
   }
   if (!argp2) {
-    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_t_swap" "', argument " "2"" of type '" "std::vector< std::pair< double,double > > &""'"); 
+    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_T_swap" "', argument " "2"" of type '" "std::vector< std::pair< double,double > > &""'"); 
   }
   arg2 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp2);
   (arg1)->swap(*arg2);
@@ -23723,7 +23723,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_begin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_begin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -23736,7 +23736,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_begin(PyObject *self, PyObjec
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_begin" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_begin" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = (arg1)->begin();
@@ -23748,7 +23748,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_end(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_end(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -23761,7 +23761,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_end(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_end" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_end" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = (arg1)->end();
@@ -23773,7 +23773,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_rbegin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_rbegin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -23786,7 +23786,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_rbegin(PyObject *self, PyObje
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_rbegin" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_rbegin" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = (arg1)->rbegin();
@@ -23798,7 +23798,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_rend(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_rend(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -23811,7 +23811,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_rend(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_rend" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_rend" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = (arg1)->rend();
@@ -23823,7 +23823,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_clear(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_clear(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -23835,7 +23835,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_clear(PyObject *self, PyObjec
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_clear" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_clear" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   (arg1)->clear();
@@ -23846,7 +23846,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_get_allocator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_get_allocator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -23859,7 +23859,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_get_allocator(PyObject *self,
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_get_allocator" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_get_allocator" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = ((std::vector< std::pair< double,double > > const *)arg1)->get_allocator();
@@ -23870,7 +23870,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_t__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_T__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > >::size_type arg1 ;
   size_t val1 ;
@@ -23881,7 +23881,7 @@ SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_t__SWIG_2(PyObject *self, P
   if ((nobjs < 1) || (nobjs > 1)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_pvacuum_double_t" "', argument " "1"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_pvacuum_double_T" "', argument " "1"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
   } 
   arg1 = static_cast< std::vector< std::pair< double,double > >::size_type >(val1);
   result = (std::vector< std::pair< double,double > > *)new std::vector< std::pair< double,double > >(arg1);
@@ -23892,7 +23892,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_pop_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_pop_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -23904,7 +23904,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_pop_back(PyObject *self, PyOb
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_pop_back" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_pop_back" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   (arg1)->pop_back();
@@ -23915,7 +23915,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::size_type arg2 ;
@@ -23928,12 +23928,12 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_resize__SWIG_0(PyObject *self
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_resize" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_resize" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_t_resize" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_T_resize" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::pair< double,double > >::size_type >(val2);
   (arg1)->resize(arg2);
@@ -23944,7 +23944,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::iterator arg2 ;
@@ -23958,18 +23958,18 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_erase__SWIG_0(PyObject *self,
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_erase" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_erase" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t_erase" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T_erase" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t_erase" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T_erase" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
     }
   }
   result = std_vector_Sl_std_pair_Sl_double_Sc_double_Sg__Sg__erase__SWIG_0(arg1,SWIG_STD_MOVE(arg2));
@@ -23981,7 +23981,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::iterator arg2 ;
@@ -23998,29 +23998,29 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_erase__SWIG_1(PyObject *self,
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_erase" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_erase" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t_erase" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T_erase" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t_erase" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T_erase" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
     }
   }
   res3 = SWIG_ConvertPtr(swig_obj[2], SWIG_as_voidptrptr(&iter3), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res3) || !iter3) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t_erase" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T_erase" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *>(iter3);
     if (iter_t) {
       arg3 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t_erase" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T_erase" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
     }
   }
   result = std_vector_Sl_std_pair_Sl_double_Sc_double_Sg__Sg__erase__SWIG_1(arg1,SWIG_STD_MOVE(arg2),SWIG_STD_MOVE(arg3));
@@ -24032,13 +24032,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_erase(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_erase(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t_erase", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T_erase", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -24049,7 +24049,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_erase(PyObject *self, PyObjec
       int res = SWIG_ConvertPtr(argv[1], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
       _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *>(iter) != 0));
       if (_v) {
-        return _wrap_vector_pvacuum_double_t_erase__SWIG_0(self, argc, argv);
+        return _wrap_vector_pvacuum_double_T_erase__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -24066,14 +24066,14 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_erase(PyObject *self, PyObjec
         int res = SWIG_ConvertPtr(argv[2], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
         _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *>(iter) != 0));
         if (_v) {
-          return _wrap_vector_pvacuum_double_t_erase__SWIG_1(self, argc, argv);
+          return _wrap_vector_pvacuum_double_T_erase__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_t_erase'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_T_erase'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::pair< double,double > >::erase(std::vector< std::pair< double,double > >::iterator)\n"
     "    std::vector< std::pair< double,double > >::erase(std::vector< std::pair< double,double > >::iterator,std::vector< std::pair< double,double > >::iterator)\n");
@@ -24081,7 +24081,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_t__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_T__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > >::size_type arg1 ;
   std::vector< std::pair< double,double > >::value_type *arg2 = 0 ;
@@ -24094,17 +24094,17 @@ SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_t__SWIG_3(PyObject *self, P
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_pvacuum_double_t" "', argument " "1"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_pvacuum_double_T" "', argument " "1"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
   } 
   arg1 = static_cast< std::vector< std::pair< double,double > >::size_type >(val1);
   {
     std::pair< double,double > *ptr = (std::pair< double,double > *)0;
     res2 = swig::asptr(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "new_vector_pvacuum_double_t" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "new_vector_pvacuum_double_T" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_pvacuum_double_t" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_pvacuum_double_T" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -24118,16 +24118,16 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_T(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vector_pvacuum_double_t", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vector_pvacuum_double_T", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 0) {
-    return _wrap_new_vector_pvacuum_double_t__SWIG_0(self, argc, argv);
+    return _wrap_new_vector_pvacuum_double_T__SWIG_0(self, argc, argv);
   }
   if (argc == 1) {
     int _v = 0;
@@ -24136,7 +24136,7 @@ SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_t(PyObject *self, PyObject
       _v = SWIG_CheckState(res);
     }
     if (_v) {
-      return _wrap_new_vector_pvacuum_double_t__SWIG_2(self, argc, argv);
+      return _wrap_new_vector_pvacuum_double_T__SWIG_2(self, argc, argv);
     }
   }
   if (argc == 1) {
@@ -24144,7 +24144,7 @@ SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_t(PyObject *self, PyObject
     int res = swig::asptr(argv[0], (std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > >**)(0));
     _v = SWIG_CheckState(res);
     if (_v) {
-      return _wrap_new_vector_pvacuum_double_t__SWIG_1(self, argc, argv);
+      return _wrap_new_vector_pvacuum_double_T__SWIG_1(self, argc, argv);
     }
   }
   if (argc == 2) {
@@ -24157,13 +24157,13 @@ SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_t(PyObject *self, PyObject
       int res = swig::asptr(argv[1], (std::pair< double,double >**)(0));
       _v = SWIG_CheckState(res);
       if (_v) {
-        return _wrap_new_vector_pvacuum_double_t__SWIG_3(self, argc, argv);
+        return _wrap_new_vector_pvacuum_double_T__SWIG_3(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vector_pvacuum_double_t'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vector_pvacuum_double_T'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::pair< double,double > >::vector()\n"
     "    std::vector< std::pair< double,double > >::vector(std::vector< std::pair< double,double > > const &)\n"
@@ -24173,7 +24173,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_push_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_push_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::value_type *arg2 = 0 ;
@@ -24183,20 +24183,20 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_push_back(PyObject *self, PyO
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t_push_back", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T_push_back", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_push_back" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_push_back" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   {
     std::pair< double,double > *ptr = (std::pair< double,double > *)0;
     res2 = swig::asptr(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_pvacuum_double_t_push_back" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_pvacuum_double_T_push_back" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_t_push_back" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_T_push_back" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -24210,7 +24210,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_front(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_front(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -24223,7 +24223,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_front(PyObject *self, PyObjec
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_front" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_front" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = (std::vector< std::pair< double,double > >::value_type *) &((std::vector< std::pair< double,double > > const *)arg1)->front();
@@ -24235,7 +24235,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -24248,7 +24248,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_back(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_back" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_back" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = (std::vector< std::pair< double,double > >::value_type *) &((std::vector< std::pair< double,double > > const *)arg1)->back();
@@ -24260,7 +24260,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_assign(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_assign(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::size_type arg2 ;
@@ -24273,25 +24273,25 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_assign(PyObject *self, PyObje
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t_assign", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T_assign", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_assign" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_assign" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_t_assign" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_T_assign" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::pair< double,double > >::size_type >(val2);
   {
     std::pair< double,double > *ptr = (std::pair< double,double > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_pvacuum_double_t_assign" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_pvacuum_double_T_assign" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_t_assign" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_T_assign" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -24305,7 +24305,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::size_type arg2 ;
@@ -24320,22 +24320,22 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_resize__SWIG_1(PyObject *self
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_resize" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_resize" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_t_resize" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_T_resize" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::pair< double,double > >::size_type >(val2);
   {
     std::pair< double,double > *ptr = (std::pair< double,double > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_pvacuum_double_t_resize" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_pvacuum_double_T_resize" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_t_resize" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_T_resize" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -24349,13 +24349,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_resize(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_resize(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t_resize", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T_resize", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -24367,7 +24367,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_resize(PyObject *self, PyObje
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_pvacuum_double_t_resize__SWIG_0(self, argc, argv);
+        return _wrap_vector_pvacuum_double_T_resize__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -24384,14 +24384,14 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_resize(PyObject *self, PyObje
         int res = swig::asptr(argv[2], (std::pair< double,double >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vector_pvacuum_double_t_resize__SWIG_1(self, argc, argv);
+          return _wrap_vector_pvacuum_double_T_resize__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_t_resize'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_T_resize'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::pair< double,double > >::resize(std::vector< std::pair< double,double > >::size_type)\n"
     "    std::vector< std::pair< double,double > >::resize(std::vector< std::pair< double,double > >::size_type,std::vector< std::pair< double,double > >::value_type const &)\n");
@@ -24399,7 +24399,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::iterator arg2 ;
@@ -24415,28 +24415,28 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_insert__SWIG_0(PyObject *self
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_insert" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_insert" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t_insert" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T_insert" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t_insert" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T_insert" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
     }
   }
   {
     std::pair< double,double > *ptr = (std::pair< double,double > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_pvacuum_double_t_insert" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_pvacuum_double_T_insert" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_t_insert" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_T_insert" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -24451,7 +24451,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::iterator arg2 ;
@@ -24469,33 +24469,33 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_insert__SWIG_1(PyObject *self
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_insert" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_insert" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t_insert" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T_insert" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t_insert" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T_insert" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_size_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_pvacuum_double_t_insert" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_pvacuum_double_T_insert" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
   } 
   arg3 = static_cast< std::vector< std::pair< double,double > >::size_type >(val3);
   {
     std::pair< double,double > *ptr = (std::pair< double,double > *)0;
     res4 = swig::asptr(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_pvacuum_double_t_insert" "', argument " "4"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_pvacuum_double_T_insert" "', argument " "4"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_t_insert" "', argument " "4"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_T_insert" "', argument " "4"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     arg4 = ptr;
   }
@@ -24509,13 +24509,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_insert(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_insert(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t_insert", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T_insert", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -24529,7 +24529,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_insert(PyObject *self, PyObje
         int res = swig::asptr(argv[2], (std::pair< double,double >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vector_pvacuum_double_t_insert__SWIG_0(self, argc, argv);
+          return _wrap_vector_pvacuum_double_T_insert__SWIG_0(self, argc, argv);
         }
       }
     }
@@ -24551,7 +24551,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_insert(PyObject *self, PyObje
           int res = swig::asptr(argv[3], (std::pair< double,double >**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vector_pvacuum_double_t_insert__SWIG_1(self, argc, argv);
+            return _wrap_vector_pvacuum_double_T_insert__SWIG_1(self, argc, argv);
           }
         }
       }
@@ -24559,7 +24559,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_insert(PyObject *self, PyObje
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_t_insert'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_T_insert'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::pair< double,double > >::insert(std::vector< std::pair< double,double > >::iterator,std::vector< std::pair< double,double > >::value_type const &)\n"
     "    std::vector< std::pair< double,double > >::insert(std::vector< std::pair< double,double > >::iterator,std::vector< std::pair< double,double > >::size_type,std::vector< std::pair< double,double > >::value_type const &)\n");
@@ -24567,7 +24567,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_reserve(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_reserve(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::size_type arg2 ;
@@ -24578,15 +24578,15 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_reserve(PyObject *self, PyObj
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t_reserve", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T_reserve", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_reserve" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_reserve" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_t_reserve" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_T_reserve" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::pair< double,double > >::size_type >(val2);
   (arg1)->reserve(arg2);
@@ -24597,7 +24597,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_capacity(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_capacity(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -24610,7 +24610,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_capacity(PyObject *self, PyOb
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_capacity" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_capacity" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = ((std::vector< std::pair< double,double > > const *)arg1)->capacity();
@@ -24621,7 +24621,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_delete_vector_pvacuum_double_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_delete_vector_pvacuum_double_T(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -24633,7 +24633,7 @@ SWIGINTERN PyObject *_wrap_delete_vector_pvacuum_double_t(PyObject *self, PyObje
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, SWIG_POINTER_DISOWN |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vector_pvacuum_double_t" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vector_pvacuum_double_T" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   {
@@ -24654,14 +24654,14 @@ fail:
 }
 
 
-SWIGINTERN PyObject *vector_pvacuum_double_t_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vector_pvacuum_double_T_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   PyObject *obj;
   if (!SWIG_Python_UnpackTuple(args, "swigregister", 1, 1, &obj)) return NULL;
   SWIG_TypeNewClientData(SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, SWIG_NewClientData(obj));
   return SWIG_Py_Void();
 }
 
-SWIGINTERN PyObject *vector_pvacuum_double_t_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vector_pvacuum_double_T_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   return SWIG_Python_InitShadowInstance(args);
 }
 
@@ -29764,558 +29764,558 @@ static PyMethodDef SwigMethods[] = {
 		"SwigPyIterator___sub__(SwigPyIterator self, SwigPyIterator x) -> ptrdiff_t\n"
 		""},
 	 { "SwigPyIterator_swigregister", SwigPyIterator_swigregister, METH_O, NULL},
-	 { "vdouble1d_t_iterator", _wrap_vdouble1d_t_iterator, METH_O, "vdouble1d_t_iterator(vdouble1d_t self) -> SwigPyIterator"},
-	 { "vdouble1d_t___nonzero__", _wrap_vdouble1d_t___nonzero__, METH_O, "vdouble1d_t___nonzero__(vdouble1d_t self) -> bool"},
-	 { "vdouble1d_t___bool__", _wrap_vdouble1d_t___bool__, METH_O, "vdouble1d_t___bool__(vdouble1d_t self) -> bool"},
-	 { "vdouble1d_t___len__", _wrap_vdouble1d_t___len__, METH_O, "vdouble1d_t___len__(vdouble1d_t self) -> std::vector< double >::size_type"},
-	 { "vdouble1d_t___getslice__", _wrap_vdouble1d_t___getslice__, METH_VARARGS, "vdouble1d_t___getslice__(vdouble1d_t self, std::vector< double >::difference_type i, std::vector< double >::difference_type j) -> vdouble1d_t"},
-	 { "vdouble1d_t___setslice__", _wrap_vdouble1d_t___setslice__, METH_VARARGS, "\n"
-		"vdouble1d_t___setslice__(vdouble1d_t self, std::vector< double >::difference_type i, std::vector< double >::difference_type j)\n"
-		"vdouble1d_t___setslice__(vdouble1d_t self, std::vector< double >::difference_type i, std::vector< double >::difference_type j, vdouble1d_t v)\n"
+	 { "vdouble1d_T_iterator", _wrap_vdouble1d_T_iterator, METH_O, "vdouble1d_T_iterator(vdouble1d_T self) -> SwigPyIterator"},
+	 { "vdouble1d_T___nonzero__", _wrap_vdouble1d_T___nonzero__, METH_O, "vdouble1d_T___nonzero__(vdouble1d_T self) -> bool"},
+	 { "vdouble1d_T___bool__", _wrap_vdouble1d_T___bool__, METH_O, "vdouble1d_T___bool__(vdouble1d_T self) -> bool"},
+	 { "vdouble1d_T___len__", _wrap_vdouble1d_T___len__, METH_O, "vdouble1d_T___len__(vdouble1d_T self) -> std::vector< double >::size_type"},
+	 { "vdouble1d_T___getslice__", _wrap_vdouble1d_T___getslice__, METH_VARARGS, "vdouble1d_T___getslice__(vdouble1d_T self, std::vector< double >::difference_type i, std::vector< double >::difference_type j) -> vdouble1d_T"},
+	 { "vdouble1d_T___setslice__", _wrap_vdouble1d_T___setslice__, METH_VARARGS, "\n"
+		"vdouble1d_T___setslice__(vdouble1d_T self, std::vector< double >::difference_type i, std::vector< double >::difference_type j)\n"
+		"vdouble1d_T___setslice__(vdouble1d_T self, std::vector< double >::difference_type i, std::vector< double >::difference_type j, vdouble1d_T v)\n"
 		""},
-	 { "vdouble1d_t___delslice__", _wrap_vdouble1d_t___delslice__, METH_VARARGS, "vdouble1d_t___delslice__(vdouble1d_t self, std::vector< double >::difference_type i, std::vector< double >::difference_type j)"},
-	 { "vdouble1d_t___delitem__", _wrap_vdouble1d_t___delitem__, METH_VARARGS, "\n"
-		"vdouble1d_t___delitem__(vdouble1d_t self, std::vector< double >::difference_type i)\n"
-		"vdouble1d_t___delitem__(vdouble1d_t self, SWIGPY_SLICEOBJECT * slice)\n"
+	 { "vdouble1d_T___delslice__", _wrap_vdouble1d_T___delslice__, METH_VARARGS, "vdouble1d_T___delslice__(vdouble1d_T self, std::vector< double >::difference_type i, std::vector< double >::difference_type j)"},
+	 { "vdouble1d_T___delitem__", _wrap_vdouble1d_T___delitem__, METH_VARARGS, "\n"
+		"vdouble1d_T___delitem__(vdouble1d_T self, std::vector< double >::difference_type i)\n"
+		"vdouble1d_T___delitem__(vdouble1d_T self, SWIGPY_SLICEOBJECT * slice)\n"
 		""},
-	 { "vdouble1d_t___getitem__", _wrap_vdouble1d_t___getitem__, METH_VARARGS, "\n"
-		"vdouble1d_t___getitem__(vdouble1d_t self, SWIGPY_SLICEOBJECT * slice) -> vdouble1d_t\n"
-		"vdouble1d_t___getitem__(vdouble1d_t self, std::vector< double >::difference_type i) -> std::vector< double >::value_type const &\n"
+	 { "vdouble1d_T___getitem__", _wrap_vdouble1d_T___getitem__, METH_VARARGS, "\n"
+		"vdouble1d_T___getitem__(vdouble1d_T self, SWIGPY_SLICEOBJECT * slice) -> vdouble1d_T\n"
+		"vdouble1d_T___getitem__(vdouble1d_T self, std::vector< double >::difference_type i) -> std::vector< double >::value_type const &\n"
 		""},
-	 { "vdouble1d_t___setitem__", _wrap_vdouble1d_t___setitem__, METH_VARARGS, "\n"
-		"vdouble1d_t___setitem__(vdouble1d_t self, SWIGPY_SLICEOBJECT * slice, vdouble1d_t v)\n"
-		"vdouble1d_t___setitem__(vdouble1d_t self, SWIGPY_SLICEOBJECT * slice)\n"
-		"vdouble1d_t___setitem__(vdouble1d_t self, std::vector< double >::difference_type i, std::vector< double >::value_type const & x)\n"
+	 { "vdouble1d_T___setitem__", _wrap_vdouble1d_T___setitem__, METH_VARARGS, "\n"
+		"vdouble1d_T___setitem__(vdouble1d_T self, SWIGPY_SLICEOBJECT * slice, vdouble1d_T v)\n"
+		"vdouble1d_T___setitem__(vdouble1d_T self, SWIGPY_SLICEOBJECT * slice)\n"
+		"vdouble1d_T___setitem__(vdouble1d_T self, std::vector< double >::difference_type i, std::vector< double >::value_type const & x)\n"
 		""},
-	 { "vdouble1d_t_pop", _wrap_vdouble1d_t_pop, METH_O, "vdouble1d_t_pop(vdouble1d_t self) -> std::vector< double >::value_type"},
-	 { "vdouble1d_t_append", _wrap_vdouble1d_t_append, METH_VARARGS, "vdouble1d_t_append(vdouble1d_t self, std::vector< double >::value_type const & x)"},
-	 { "vdouble1d_t_empty", _wrap_vdouble1d_t_empty, METH_O, "vdouble1d_t_empty(vdouble1d_t self) -> bool"},
-	 { "vdouble1d_t_size", _wrap_vdouble1d_t_size, METH_O, "vdouble1d_t_size(vdouble1d_t self) -> std::vector< double >::size_type"},
-	 { "vdouble1d_t_swap", _wrap_vdouble1d_t_swap, METH_VARARGS, "vdouble1d_t_swap(vdouble1d_t self, vdouble1d_t v)"},
-	 { "vdouble1d_t_begin", _wrap_vdouble1d_t_begin, METH_O, "vdouble1d_t_begin(vdouble1d_t self) -> std::vector< double >::iterator"},
-	 { "vdouble1d_t_end", _wrap_vdouble1d_t_end, METH_O, "vdouble1d_t_end(vdouble1d_t self) -> std::vector< double >::iterator"},
-	 { "vdouble1d_t_rbegin", _wrap_vdouble1d_t_rbegin, METH_O, "vdouble1d_t_rbegin(vdouble1d_t self) -> std::vector< double >::reverse_iterator"},
-	 { "vdouble1d_t_rend", _wrap_vdouble1d_t_rend, METH_O, "vdouble1d_t_rend(vdouble1d_t self) -> std::vector< double >::reverse_iterator"},
-	 { "vdouble1d_t_clear", _wrap_vdouble1d_t_clear, METH_O, "vdouble1d_t_clear(vdouble1d_t self)"},
-	 { "vdouble1d_t_get_allocator", _wrap_vdouble1d_t_get_allocator, METH_O, "vdouble1d_t_get_allocator(vdouble1d_t self) -> std::vector< double >::allocator_type"},
-	 { "vdouble1d_t_pop_back", _wrap_vdouble1d_t_pop_back, METH_O, "vdouble1d_t_pop_back(vdouble1d_t self)"},
-	 { "vdouble1d_t_erase", _wrap_vdouble1d_t_erase, METH_VARARGS, "\n"
-		"vdouble1d_t_erase(vdouble1d_t self, std::vector< double >::iterator pos) -> std::vector< double >::iterator\n"
-		"vdouble1d_t_erase(vdouble1d_t self, std::vector< double >::iterator first, std::vector< double >::iterator last) -> std::vector< double >::iterator\n"
+	 { "vdouble1d_T_pop", _wrap_vdouble1d_T_pop, METH_O, "vdouble1d_T_pop(vdouble1d_T self) -> std::vector< double >::value_type"},
+	 { "vdouble1d_T_append", _wrap_vdouble1d_T_append, METH_VARARGS, "vdouble1d_T_append(vdouble1d_T self, std::vector< double >::value_type const & x)"},
+	 { "vdouble1d_T_empty", _wrap_vdouble1d_T_empty, METH_O, "vdouble1d_T_empty(vdouble1d_T self) -> bool"},
+	 { "vdouble1d_T_size", _wrap_vdouble1d_T_size, METH_O, "vdouble1d_T_size(vdouble1d_T self) -> std::vector< double >::size_type"},
+	 { "vdouble1d_T_swap", _wrap_vdouble1d_T_swap, METH_VARARGS, "vdouble1d_T_swap(vdouble1d_T self, vdouble1d_T v)"},
+	 { "vdouble1d_T_begin", _wrap_vdouble1d_T_begin, METH_O, "vdouble1d_T_begin(vdouble1d_T self) -> std::vector< double >::iterator"},
+	 { "vdouble1d_T_end", _wrap_vdouble1d_T_end, METH_O, "vdouble1d_T_end(vdouble1d_T self) -> std::vector< double >::iterator"},
+	 { "vdouble1d_T_rbegin", _wrap_vdouble1d_T_rbegin, METH_O, "vdouble1d_T_rbegin(vdouble1d_T self) -> std::vector< double >::reverse_iterator"},
+	 { "vdouble1d_T_rend", _wrap_vdouble1d_T_rend, METH_O, "vdouble1d_T_rend(vdouble1d_T self) -> std::vector< double >::reverse_iterator"},
+	 { "vdouble1d_T_clear", _wrap_vdouble1d_T_clear, METH_O, "vdouble1d_T_clear(vdouble1d_T self)"},
+	 { "vdouble1d_T_get_allocator", _wrap_vdouble1d_T_get_allocator, METH_O, "vdouble1d_T_get_allocator(vdouble1d_T self) -> std::vector< double >::allocator_type"},
+	 { "vdouble1d_T_pop_back", _wrap_vdouble1d_T_pop_back, METH_O, "vdouble1d_T_pop_back(vdouble1d_T self)"},
+	 { "vdouble1d_T_erase", _wrap_vdouble1d_T_erase, METH_VARARGS, "\n"
+		"vdouble1d_T_erase(vdouble1d_T self, std::vector< double >::iterator pos) -> std::vector< double >::iterator\n"
+		"vdouble1d_T_erase(vdouble1d_T self, std::vector< double >::iterator first, std::vector< double >::iterator last) -> std::vector< double >::iterator\n"
 		""},
-	 { "new_vdouble1d_t", _wrap_new_vdouble1d_t, METH_VARARGS, "\n"
-		"vdouble1d_t()\n"
-		"vdouble1d_t(vdouble1d_t other)\n"
-		"vdouble1d_t(std::vector< double >::size_type size)\n"
-		"new_vdouble1d_t(std::vector< double >::size_type size, std::vector< double >::value_type const & value) -> vdouble1d_t\n"
+	 { "new_vdouble1d_T", _wrap_new_vdouble1d_T, METH_VARARGS, "\n"
+		"vdouble1d_T()\n"
+		"vdouble1d_T(vdouble1d_T other)\n"
+		"vdouble1d_T(std::vector< double >::size_type size)\n"
+		"new_vdouble1d_T(std::vector< double >::size_type size, std::vector< double >::value_type const & value) -> vdouble1d_T\n"
 		""},
-	 { "vdouble1d_t_push_back", _wrap_vdouble1d_t_push_back, METH_VARARGS, "vdouble1d_t_push_back(vdouble1d_t self, std::vector< double >::value_type const & x)"},
-	 { "vdouble1d_t_front", _wrap_vdouble1d_t_front, METH_O, "vdouble1d_t_front(vdouble1d_t self) -> std::vector< double >::value_type const &"},
-	 { "vdouble1d_t_back", _wrap_vdouble1d_t_back, METH_O, "vdouble1d_t_back(vdouble1d_t self) -> std::vector< double >::value_type const &"},
-	 { "vdouble1d_t_assign", _wrap_vdouble1d_t_assign, METH_VARARGS, "vdouble1d_t_assign(vdouble1d_t self, std::vector< double >::size_type n, std::vector< double >::value_type const & x)"},
-	 { "vdouble1d_t_resize", _wrap_vdouble1d_t_resize, METH_VARARGS, "\n"
-		"vdouble1d_t_resize(vdouble1d_t self, std::vector< double >::size_type new_size)\n"
-		"vdouble1d_t_resize(vdouble1d_t self, std::vector< double >::size_type new_size, std::vector< double >::value_type const & x)\n"
+	 { "vdouble1d_T_push_back", _wrap_vdouble1d_T_push_back, METH_VARARGS, "vdouble1d_T_push_back(vdouble1d_T self, std::vector< double >::value_type const & x)"},
+	 { "vdouble1d_T_front", _wrap_vdouble1d_T_front, METH_O, "vdouble1d_T_front(vdouble1d_T self) -> std::vector< double >::value_type const &"},
+	 { "vdouble1d_T_back", _wrap_vdouble1d_T_back, METH_O, "vdouble1d_T_back(vdouble1d_T self) -> std::vector< double >::value_type const &"},
+	 { "vdouble1d_T_assign", _wrap_vdouble1d_T_assign, METH_VARARGS, "vdouble1d_T_assign(vdouble1d_T self, std::vector< double >::size_type n, std::vector< double >::value_type const & x)"},
+	 { "vdouble1d_T_resize", _wrap_vdouble1d_T_resize, METH_VARARGS, "\n"
+		"vdouble1d_T_resize(vdouble1d_T self, std::vector< double >::size_type new_size)\n"
+		"vdouble1d_T_resize(vdouble1d_T self, std::vector< double >::size_type new_size, std::vector< double >::value_type const & x)\n"
 		""},
-	 { "vdouble1d_t_insert", _wrap_vdouble1d_t_insert, METH_VARARGS, "\n"
-		"vdouble1d_t_insert(vdouble1d_t self, std::vector< double >::iterator pos, std::vector< double >::value_type const & x) -> std::vector< double >::iterator\n"
-		"vdouble1d_t_insert(vdouble1d_t self, std::vector< double >::iterator pos, std::vector< double >::size_type n, std::vector< double >::value_type const & x)\n"
+	 { "vdouble1d_T_insert", _wrap_vdouble1d_T_insert, METH_VARARGS, "\n"
+		"vdouble1d_T_insert(vdouble1d_T self, std::vector< double >::iterator pos, std::vector< double >::value_type const & x) -> std::vector< double >::iterator\n"
+		"vdouble1d_T_insert(vdouble1d_T self, std::vector< double >::iterator pos, std::vector< double >::size_type n, std::vector< double >::value_type const & x)\n"
 		""},
-	 { "vdouble1d_t_reserve", _wrap_vdouble1d_t_reserve, METH_VARARGS, "vdouble1d_t_reserve(vdouble1d_t self, std::vector< double >::size_type n)"},
-	 { "vdouble1d_t_capacity", _wrap_vdouble1d_t_capacity, METH_O, "vdouble1d_t_capacity(vdouble1d_t self) -> std::vector< double >::size_type"},
-	 { "delete_vdouble1d_t", _wrap_delete_vdouble1d_t, METH_O, "delete_vdouble1d_t(vdouble1d_t self)"},
-	 { "vdouble1d_t_swigregister", vdouble1d_t_swigregister, METH_O, NULL},
-	 { "vdouble1d_t_swiginit", vdouble1d_t_swiginit, METH_VARARGS, NULL},
-	 { "vdouble2d_t_iterator", _wrap_vdouble2d_t_iterator, METH_O, "vdouble2d_t_iterator(vdouble2d_t self) -> SwigPyIterator"},
-	 { "vdouble2d_t___nonzero__", _wrap_vdouble2d_t___nonzero__, METH_O, "vdouble2d_t___nonzero__(vdouble2d_t self) -> bool"},
-	 { "vdouble2d_t___bool__", _wrap_vdouble2d_t___bool__, METH_O, "vdouble2d_t___bool__(vdouble2d_t self) -> bool"},
-	 { "vdouble2d_t___len__", _wrap_vdouble2d_t___len__, METH_O, "vdouble2d_t___len__(vdouble2d_t self) -> std::vector< std::vector< double > >::size_type"},
-	 { "vdouble2d_t___getslice__", _wrap_vdouble2d_t___getslice__, METH_VARARGS, "vdouble2d_t___getslice__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j) -> vdouble2d_t"},
-	 { "vdouble2d_t___setslice__", _wrap_vdouble2d_t___setslice__, METH_VARARGS, "\n"
-		"vdouble2d_t___setslice__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j)\n"
-		"vdouble2d_t___setslice__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j, vdouble2d_t v)\n"
+	 { "vdouble1d_T_reserve", _wrap_vdouble1d_T_reserve, METH_VARARGS, "vdouble1d_T_reserve(vdouble1d_T self, std::vector< double >::size_type n)"},
+	 { "vdouble1d_T_capacity", _wrap_vdouble1d_T_capacity, METH_O, "vdouble1d_T_capacity(vdouble1d_T self) -> std::vector< double >::size_type"},
+	 { "delete_vdouble1d_T", _wrap_delete_vdouble1d_T, METH_O, "delete_vdouble1d_T(vdouble1d_T self)"},
+	 { "vdouble1d_T_swigregister", vdouble1d_T_swigregister, METH_O, NULL},
+	 { "vdouble1d_T_swiginit", vdouble1d_T_swiginit, METH_VARARGS, NULL},
+	 { "vdouble2d_T_iterator", _wrap_vdouble2d_T_iterator, METH_O, "vdouble2d_T_iterator(vdouble2d_T self) -> SwigPyIterator"},
+	 { "vdouble2d_T___nonzero__", _wrap_vdouble2d_T___nonzero__, METH_O, "vdouble2d_T___nonzero__(vdouble2d_T self) -> bool"},
+	 { "vdouble2d_T___bool__", _wrap_vdouble2d_T___bool__, METH_O, "vdouble2d_T___bool__(vdouble2d_T self) -> bool"},
+	 { "vdouble2d_T___len__", _wrap_vdouble2d_T___len__, METH_O, "vdouble2d_T___len__(vdouble2d_T self) -> std::vector< std::vector< double > >::size_type"},
+	 { "vdouble2d_T___getslice__", _wrap_vdouble2d_T___getslice__, METH_VARARGS, "vdouble2d_T___getslice__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j) -> vdouble2d_T"},
+	 { "vdouble2d_T___setslice__", _wrap_vdouble2d_T___setslice__, METH_VARARGS, "\n"
+		"vdouble2d_T___setslice__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j)\n"
+		"vdouble2d_T___setslice__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j, vdouble2d_T v)\n"
 		""},
-	 { "vdouble2d_t___delslice__", _wrap_vdouble2d_t___delslice__, METH_VARARGS, "vdouble2d_t___delslice__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j)"},
-	 { "vdouble2d_t___delitem__", _wrap_vdouble2d_t___delitem__, METH_VARARGS, "\n"
-		"vdouble2d_t___delitem__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i)\n"
-		"vdouble2d_t___delitem__(vdouble2d_t self, SWIGPY_SLICEOBJECT * slice)\n"
+	 { "vdouble2d_T___delslice__", _wrap_vdouble2d_T___delslice__, METH_VARARGS, "vdouble2d_T___delslice__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j)"},
+	 { "vdouble2d_T___delitem__", _wrap_vdouble2d_T___delitem__, METH_VARARGS, "\n"
+		"vdouble2d_T___delitem__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i)\n"
+		"vdouble2d_T___delitem__(vdouble2d_T self, SWIGPY_SLICEOBJECT * slice)\n"
 		""},
-	 { "vdouble2d_t___getitem__", _wrap_vdouble2d_t___getitem__, METH_VARARGS, "\n"
-		"vdouble2d_t___getitem__(vdouble2d_t self, SWIGPY_SLICEOBJECT * slice) -> vdouble2d_t\n"
-		"vdouble2d_t___getitem__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i) -> vdouble1d_t\n"
+	 { "vdouble2d_T___getitem__", _wrap_vdouble2d_T___getitem__, METH_VARARGS, "\n"
+		"vdouble2d_T___getitem__(vdouble2d_T self, SWIGPY_SLICEOBJECT * slice) -> vdouble2d_T\n"
+		"vdouble2d_T___getitem__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i) -> vdouble1d_T\n"
 		""},
-	 { "vdouble2d_t___setitem__", _wrap_vdouble2d_t___setitem__, METH_VARARGS, "\n"
-		"vdouble2d_t___setitem__(vdouble2d_t self, SWIGPY_SLICEOBJECT * slice, vdouble2d_t v)\n"
-		"vdouble2d_t___setitem__(vdouble2d_t self, SWIGPY_SLICEOBJECT * slice)\n"
-		"vdouble2d_t___setitem__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i, vdouble1d_t x)\n"
+	 { "vdouble2d_T___setitem__", _wrap_vdouble2d_T___setitem__, METH_VARARGS, "\n"
+		"vdouble2d_T___setitem__(vdouble2d_T self, SWIGPY_SLICEOBJECT * slice, vdouble2d_T v)\n"
+		"vdouble2d_T___setitem__(vdouble2d_T self, SWIGPY_SLICEOBJECT * slice)\n"
+		"vdouble2d_T___setitem__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i, vdouble1d_T x)\n"
 		""},
-	 { "vdouble2d_t_pop", _wrap_vdouble2d_t_pop, METH_O, "vdouble2d_t_pop(vdouble2d_t self) -> vdouble1d_t"},
-	 { "vdouble2d_t_append", _wrap_vdouble2d_t_append, METH_VARARGS, "vdouble2d_t_append(vdouble2d_t self, vdouble1d_t x)"},
-	 { "vdouble2d_t_empty", _wrap_vdouble2d_t_empty, METH_O, "vdouble2d_t_empty(vdouble2d_t self) -> bool"},
-	 { "vdouble2d_t_size", _wrap_vdouble2d_t_size, METH_O, "vdouble2d_t_size(vdouble2d_t self) -> std::vector< std::vector< double > >::size_type"},
-	 { "vdouble2d_t_swap", _wrap_vdouble2d_t_swap, METH_VARARGS, "vdouble2d_t_swap(vdouble2d_t self, vdouble2d_t v)"},
-	 { "vdouble2d_t_begin", _wrap_vdouble2d_t_begin, METH_O, "vdouble2d_t_begin(vdouble2d_t self) -> std::vector< std::vector< double > >::iterator"},
-	 { "vdouble2d_t_end", _wrap_vdouble2d_t_end, METH_O, "vdouble2d_t_end(vdouble2d_t self) -> std::vector< std::vector< double > >::iterator"},
-	 { "vdouble2d_t_rbegin", _wrap_vdouble2d_t_rbegin, METH_O, "vdouble2d_t_rbegin(vdouble2d_t self) -> std::vector< std::vector< double > >::reverse_iterator"},
-	 { "vdouble2d_t_rend", _wrap_vdouble2d_t_rend, METH_O, "vdouble2d_t_rend(vdouble2d_t self) -> std::vector< std::vector< double > >::reverse_iterator"},
-	 { "vdouble2d_t_clear", _wrap_vdouble2d_t_clear, METH_O, "vdouble2d_t_clear(vdouble2d_t self)"},
-	 { "vdouble2d_t_get_allocator", _wrap_vdouble2d_t_get_allocator, METH_O, "vdouble2d_t_get_allocator(vdouble2d_t self) -> std::vector< std::vector< double > >::allocator_type"},
-	 { "vdouble2d_t_pop_back", _wrap_vdouble2d_t_pop_back, METH_O, "vdouble2d_t_pop_back(vdouble2d_t self)"},
-	 { "vdouble2d_t_erase", _wrap_vdouble2d_t_erase, METH_VARARGS, "\n"
-		"vdouble2d_t_erase(vdouble2d_t self, std::vector< std::vector< double > >::iterator pos) -> std::vector< std::vector< double > >::iterator\n"
-		"vdouble2d_t_erase(vdouble2d_t self, std::vector< std::vector< double > >::iterator first, std::vector< std::vector< double > >::iterator last) -> std::vector< std::vector< double > >::iterator\n"
+	 { "vdouble2d_T_pop", _wrap_vdouble2d_T_pop, METH_O, "vdouble2d_T_pop(vdouble2d_T self) -> vdouble1d_T"},
+	 { "vdouble2d_T_append", _wrap_vdouble2d_T_append, METH_VARARGS, "vdouble2d_T_append(vdouble2d_T self, vdouble1d_T x)"},
+	 { "vdouble2d_T_empty", _wrap_vdouble2d_T_empty, METH_O, "vdouble2d_T_empty(vdouble2d_T self) -> bool"},
+	 { "vdouble2d_T_size", _wrap_vdouble2d_T_size, METH_O, "vdouble2d_T_size(vdouble2d_T self) -> std::vector< std::vector< double > >::size_type"},
+	 { "vdouble2d_T_swap", _wrap_vdouble2d_T_swap, METH_VARARGS, "vdouble2d_T_swap(vdouble2d_T self, vdouble2d_T v)"},
+	 { "vdouble2d_T_begin", _wrap_vdouble2d_T_begin, METH_O, "vdouble2d_T_begin(vdouble2d_T self) -> std::vector< std::vector< double > >::iterator"},
+	 { "vdouble2d_T_end", _wrap_vdouble2d_T_end, METH_O, "vdouble2d_T_end(vdouble2d_T self) -> std::vector< std::vector< double > >::iterator"},
+	 { "vdouble2d_T_rbegin", _wrap_vdouble2d_T_rbegin, METH_O, "vdouble2d_T_rbegin(vdouble2d_T self) -> std::vector< std::vector< double > >::reverse_iterator"},
+	 { "vdouble2d_T_rend", _wrap_vdouble2d_T_rend, METH_O, "vdouble2d_T_rend(vdouble2d_T self) -> std::vector< std::vector< double > >::reverse_iterator"},
+	 { "vdouble2d_T_clear", _wrap_vdouble2d_T_clear, METH_O, "vdouble2d_T_clear(vdouble2d_T self)"},
+	 { "vdouble2d_T_get_allocator", _wrap_vdouble2d_T_get_allocator, METH_O, "vdouble2d_T_get_allocator(vdouble2d_T self) -> std::vector< std::vector< double > >::allocator_type"},
+	 { "vdouble2d_T_pop_back", _wrap_vdouble2d_T_pop_back, METH_O, "vdouble2d_T_pop_back(vdouble2d_T self)"},
+	 { "vdouble2d_T_erase", _wrap_vdouble2d_T_erase, METH_VARARGS, "\n"
+		"vdouble2d_T_erase(vdouble2d_T self, std::vector< std::vector< double > >::iterator pos) -> std::vector< std::vector< double > >::iterator\n"
+		"vdouble2d_T_erase(vdouble2d_T self, std::vector< std::vector< double > >::iterator first, std::vector< std::vector< double > >::iterator last) -> std::vector< std::vector< double > >::iterator\n"
 		""},
-	 { "new_vdouble2d_t", _wrap_new_vdouble2d_t, METH_VARARGS, "\n"
-		"vdouble2d_t()\n"
-		"vdouble2d_t(vdouble2d_t other)\n"
-		"vdouble2d_t(std::vector< std::vector< double > >::size_type size)\n"
-		"new_vdouble2d_t(std::vector< std::vector< double > >::size_type size, vdouble1d_t value) -> vdouble2d_t\n"
+	 { "new_vdouble2d_T", _wrap_new_vdouble2d_T, METH_VARARGS, "\n"
+		"vdouble2d_T()\n"
+		"vdouble2d_T(vdouble2d_T other)\n"
+		"vdouble2d_T(std::vector< std::vector< double > >::size_type size)\n"
+		"new_vdouble2d_T(std::vector< std::vector< double > >::size_type size, vdouble1d_T value) -> vdouble2d_T\n"
 		""},
-	 { "vdouble2d_t_push_back", _wrap_vdouble2d_t_push_back, METH_VARARGS, "vdouble2d_t_push_back(vdouble2d_t self, vdouble1d_t x)"},
-	 { "vdouble2d_t_front", _wrap_vdouble2d_t_front, METH_O, "vdouble2d_t_front(vdouble2d_t self) -> vdouble1d_t"},
-	 { "vdouble2d_t_back", _wrap_vdouble2d_t_back, METH_O, "vdouble2d_t_back(vdouble2d_t self) -> vdouble1d_t"},
-	 { "vdouble2d_t_assign", _wrap_vdouble2d_t_assign, METH_VARARGS, "vdouble2d_t_assign(vdouble2d_t self, std::vector< std::vector< double > >::size_type n, vdouble1d_t x)"},
-	 { "vdouble2d_t_resize", _wrap_vdouble2d_t_resize, METH_VARARGS, "\n"
-		"vdouble2d_t_resize(vdouble2d_t self, std::vector< std::vector< double > >::size_type new_size)\n"
-		"vdouble2d_t_resize(vdouble2d_t self, std::vector< std::vector< double > >::size_type new_size, vdouble1d_t x)\n"
+	 { "vdouble2d_T_push_back", _wrap_vdouble2d_T_push_back, METH_VARARGS, "vdouble2d_T_push_back(vdouble2d_T self, vdouble1d_T x)"},
+	 { "vdouble2d_T_front", _wrap_vdouble2d_T_front, METH_O, "vdouble2d_T_front(vdouble2d_T self) -> vdouble1d_T"},
+	 { "vdouble2d_T_back", _wrap_vdouble2d_T_back, METH_O, "vdouble2d_T_back(vdouble2d_T self) -> vdouble1d_T"},
+	 { "vdouble2d_T_assign", _wrap_vdouble2d_T_assign, METH_VARARGS, "vdouble2d_T_assign(vdouble2d_T self, std::vector< std::vector< double > >::size_type n, vdouble1d_T x)"},
+	 { "vdouble2d_T_resize", _wrap_vdouble2d_T_resize, METH_VARARGS, "\n"
+		"vdouble2d_T_resize(vdouble2d_T self, std::vector< std::vector< double > >::size_type new_size)\n"
+		"vdouble2d_T_resize(vdouble2d_T self, std::vector< std::vector< double > >::size_type new_size, vdouble1d_T x)\n"
 		""},
-	 { "vdouble2d_t_insert", _wrap_vdouble2d_t_insert, METH_VARARGS, "\n"
-		"vdouble2d_t_insert(vdouble2d_t self, std::vector< std::vector< double > >::iterator pos, vdouble1d_t x) -> std::vector< std::vector< double > >::iterator\n"
-		"vdouble2d_t_insert(vdouble2d_t self, std::vector< std::vector< double > >::iterator pos, std::vector< std::vector< double > >::size_type n, vdouble1d_t x)\n"
+	 { "vdouble2d_T_insert", _wrap_vdouble2d_T_insert, METH_VARARGS, "\n"
+		"vdouble2d_T_insert(vdouble2d_T self, std::vector< std::vector< double > >::iterator pos, vdouble1d_T x) -> std::vector< std::vector< double > >::iterator\n"
+		"vdouble2d_T_insert(vdouble2d_T self, std::vector< std::vector< double > >::iterator pos, std::vector< std::vector< double > >::size_type n, vdouble1d_T x)\n"
 		""},
-	 { "vdouble2d_t_reserve", _wrap_vdouble2d_t_reserve, METH_VARARGS, "vdouble2d_t_reserve(vdouble2d_t self, std::vector< std::vector< double > >::size_type n)"},
-	 { "vdouble2d_t_capacity", _wrap_vdouble2d_t_capacity, METH_O, "vdouble2d_t_capacity(vdouble2d_t self) -> std::vector< std::vector< double > >::size_type"},
-	 { "delete_vdouble2d_t", _wrap_delete_vdouble2d_t, METH_O, "delete_vdouble2d_t(vdouble2d_t self)"},
-	 { "vdouble2d_t_swigregister", vdouble2d_t_swigregister, METH_O, NULL},
-	 { "vdouble2d_t_swiginit", vdouble2d_t_swiginit, METH_VARARGS, NULL},
-	 { "vector_integer_t_iterator", _wrap_vector_integer_t_iterator, METH_O, "vector_integer_t_iterator(vector_integer_t self) -> SwigPyIterator"},
-	 { "vector_integer_t___nonzero__", _wrap_vector_integer_t___nonzero__, METH_O, "vector_integer_t___nonzero__(vector_integer_t self) -> bool"},
-	 { "vector_integer_t___bool__", _wrap_vector_integer_t___bool__, METH_O, "vector_integer_t___bool__(vector_integer_t self) -> bool"},
-	 { "vector_integer_t___len__", _wrap_vector_integer_t___len__, METH_O, "vector_integer_t___len__(vector_integer_t self) -> std::vector< int >::size_type"},
-	 { "vector_integer_t___getslice__", _wrap_vector_integer_t___getslice__, METH_VARARGS, "vector_integer_t___getslice__(vector_integer_t self, std::vector< int >::difference_type i, std::vector< int >::difference_type j) -> vector_integer_t"},
-	 { "vector_integer_t___setslice__", _wrap_vector_integer_t___setslice__, METH_VARARGS, "\n"
-		"vector_integer_t___setslice__(vector_integer_t self, std::vector< int >::difference_type i, std::vector< int >::difference_type j)\n"
-		"vector_integer_t___setslice__(vector_integer_t self, std::vector< int >::difference_type i, std::vector< int >::difference_type j, vector_integer_t v)\n"
+	 { "vdouble2d_T_reserve", _wrap_vdouble2d_T_reserve, METH_VARARGS, "vdouble2d_T_reserve(vdouble2d_T self, std::vector< std::vector< double > >::size_type n)"},
+	 { "vdouble2d_T_capacity", _wrap_vdouble2d_T_capacity, METH_O, "vdouble2d_T_capacity(vdouble2d_T self) -> std::vector< std::vector< double > >::size_type"},
+	 { "delete_vdouble2d_T", _wrap_delete_vdouble2d_T, METH_O, "delete_vdouble2d_T(vdouble2d_T self)"},
+	 { "vdouble2d_T_swigregister", vdouble2d_T_swigregister, METH_O, NULL},
+	 { "vdouble2d_T_swiginit", vdouble2d_T_swiginit, METH_VARARGS, NULL},
+	 { "vector_integer_T_iterator", _wrap_vector_integer_T_iterator, METH_O, "vector_integer_T_iterator(vector_integer_T self) -> SwigPyIterator"},
+	 { "vector_integer_T___nonzero__", _wrap_vector_integer_T___nonzero__, METH_O, "vector_integer_T___nonzero__(vector_integer_T self) -> bool"},
+	 { "vector_integer_T___bool__", _wrap_vector_integer_T___bool__, METH_O, "vector_integer_T___bool__(vector_integer_T self) -> bool"},
+	 { "vector_integer_T___len__", _wrap_vector_integer_T___len__, METH_O, "vector_integer_T___len__(vector_integer_T self) -> std::vector< int >::size_type"},
+	 { "vector_integer_T___getslice__", _wrap_vector_integer_T___getslice__, METH_VARARGS, "vector_integer_T___getslice__(vector_integer_T self, std::vector< int >::difference_type i, std::vector< int >::difference_type j) -> vector_integer_T"},
+	 { "vector_integer_T___setslice__", _wrap_vector_integer_T___setslice__, METH_VARARGS, "\n"
+		"vector_integer_T___setslice__(vector_integer_T self, std::vector< int >::difference_type i, std::vector< int >::difference_type j)\n"
+		"vector_integer_T___setslice__(vector_integer_T self, std::vector< int >::difference_type i, std::vector< int >::difference_type j, vector_integer_T v)\n"
 		""},
-	 { "vector_integer_t___delslice__", _wrap_vector_integer_t___delslice__, METH_VARARGS, "vector_integer_t___delslice__(vector_integer_t self, std::vector< int >::difference_type i, std::vector< int >::difference_type j)"},
-	 { "vector_integer_t___delitem__", _wrap_vector_integer_t___delitem__, METH_VARARGS, "\n"
-		"vector_integer_t___delitem__(vector_integer_t self, std::vector< int >::difference_type i)\n"
-		"vector_integer_t___delitem__(vector_integer_t self, SWIGPY_SLICEOBJECT * slice)\n"
+	 { "vector_integer_T___delslice__", _wrap_vector_integer_T___delslice__, METH_VARARGS, "vector_integer_T___delslice__(vector_integer_T self, std::vector< int >::difference_type i, std::vector< int >::difference_type j)"},
+	 { "vector_integer_T___delitem__", _wrap_vector_integer_T___delitem__, METH_VARARGS, "\n"
+		"vector_integer_T___delitem__(vector_integer_T self, std::vector< int >::difference_type i)\n"
+		"vector_integer_T___delitem__(vector_integer_T self, SWIGPY_SLICEOBJECT * slice)\n"
 		""},
-	 { "vector_integer_t___getitem__", _wrap_vector_integer_t___getitem__, METH_VARARGS, "\n"
-		"vector_integer_t___getitem__(vector_integer_t self, SWIGPY_SLICEOBJECT * slice) -> vector_integer_t\n"
-		"vector_integer_t___getitem__(vector_integer_t self, std::vector< int >::difference_type i) -> std::vector< int >::value_type const &\n"
+	 { "vector_integer_T___getitem__", _wrap_vector_integer_T___getitem__, METH_VARARGS, "\n"
+		"vector_integer_T___getitem__(vector_integer_T self, SWIGPY_SLICEOBJECT * slice) -> vector_integer_T\n"
+		"vector_integer_T___getitem__(vector_integer_T self, std::vector< int >::difference_type i) -> std::vector< int >::value_type const &\n"
 		""},
-	 { "vector_integer_t___setitem__", _wrap_vector_integer_t___setitem__, METH_VARARGS, "\n"
-		"vector_integer_t___setitem__(vector_integer_t self, SWIGPY_SLICEOBJECT * slice, vector_integer_t v)\n"
-		"vector_integer_t___setitem__(vector_integer_t self, SWIGPY_SLICEOBJECT * slice)\n"
-		"vector_integer_t___setitem__(vector_integer_t self, std::vector< int >::difference_type i, std::vector< int >::value_type const & x)\n"
+	 { "vector_integer_T___setitem__", _wrap_vector_integer_T___setitem__, METH_VARARGS, "\n"
+		"vector_integer_T___setitem__(vector_integer_T self, SWIGPY_SLICEOBJECT * slice, vector_integer_T v)\n"
+		"vector_integer_T___setitem__(vector_integer_T self, SWIGPY_SLICEOBJECT * slice)\n"
+		"vector_integer_T___setitem__(vector_integer_T self, std::vector< int >::difference_type i, std::vector< int >::value_type const & x)\n"
 		""},
-	 { "vector_integer_t_pop", _wrap_vector_integer_t_pop, METH_O, "vector_integer_t_pop(vector_integer_t self) -> std::vector< int >::value_type"},
-	 { "vector_integer_t_append", _wrap_vector_integer_t_append, METH_VARARGS, "vector_integer_t_append(vector_integer_t self, std::vector< int >::value_type const & x)"},
-	 { "vector_integer_t_empty", _wrap_vector_integer_t_empty, METH_O, "vector_integer_t_empty(vector_integer_t self) -> bool"},
-	 { "vector_integer_t_size", _wrap_vector_integer_t_size, METH_O, "vector_integer_t_size(vector_integer_t self) -> std::vector< int >::size_type"},
-	 { "vector_integer_t_swap", _wrap_vector_integer_t_swap, METH_VARARGS, "vector_integer_t_swap(vector_integer_t self, vector_integer_t v)"},
-	 { "vector_integer_t_begin", _wrap_vector_integer_t_begin, METH_O, "vector_integer_t_begin(vector_integer_t self) -> std::vector< int >::iterator"},
-	 { "vector_integer_t_end", _wrap_vector_integer_t_end, METH_O, "vector_integer_t_end(vector_integer_t self) -> std::vector< int >::iterator"},
-	 { "vector_integer_t_rbegin", _wrap_vector_integer_t_rbegin, METH_O, "vector_integer_t_rbegin(vector_integer_t self) -> std::vector< int >::reverse_iterator"},
-	 { "vector_integer_t_rend", _wrap_vector_integer_t_rend, METH_O, "vector_integer_t_rend(vector_integer_t self) -> std::vector< int >::reverse_iterator"},
-	 { "vector_integer_t_clear", _wrap_vector_integer_t_clear, METH_O, "vector_integer_t_clear(vector_integer_t self)"},
-	 { "vector_integer_t_get_allocator", _wrap_vector_integer_t_get_allocator, METH_O, "vector_integer_t_get_allocator(vector_integer_t self) -> std::vector< int >::allocator_type"},
-	 { "vector_integer_t_pop_back", _wrap_vector_integer_t_pop_back, METH_O, "vector_integer_t_pop_back(vector_integer_t self)"},
-	 { "vector_integer_t_erase", _wrap_vector_integer_t_erase, METH_VARARGS, "\n"
-		"vector_integer_t_erase(vector_integer_t self, std::vector< int >::iterator pos) -> std::vector< int >::iterator\n"
-		"vector_integer_t_erase(vector_integer_t self, std::vector< int >::iterator first, std::vector< int >::iterator last) -> std::vector< int >::iterator\n"
+	 { "vector_integer_T_pop", _wrap_vector_integer_T_pop, METH_O, "vector_integer_T_pop(vector_integer_T self) -> std::vector< int >::value_type"},
+	 { "vector_integer_T_append", _wrap_vector_integer_T_append, METH_VARARGS, "vector_integer_T_append(vector_integer_T self, std::vector< int >::value_type const & x)"},
+	 { "vector_integer_T_empty", _wrap_vector_integer_T_empty, METH_O, "vector_integer_T_empty(vector_integer_T self) -> bool"},
+	 { "vector_integer_T_size", _wrap_vector_integer_T_size, METH_O, "vector_integer_T_size(vector_integer_T self) -> std::vector< int >::size_type"},
+	 { "vector_integer_T_swap", _wrap_vector_integer_T_swap, METH_VARARGS, "vector_integer_T_swap(vector_integer_T self, vector_integer_T v)"},
+	 { "vector_integer_T_begin", _wrap_vector_integer_T_begin, METH_O, "vector_integer_T_begin(vector_integer_T self) -> std::vector< int >::iterator"},
+	 { "vector_integer_T_end", _wrap_vector_integer_T_end, METH_O, "vector_integer_T_end(vector_integer_T self) -> std::vector< int >::iterator"},
+	 { "vector_integer_T_rbegin", _wrap_vector_integer_T_rbegin, METH_O, "vector_integer_T_rbegin(vector_integer_T self) -> std::vector< int >::reverse_iterator"},
+	 { "vector_integer_T_rend", _wrap_vector_integer_T_rend, METH_O, "vector_integer_T_rend(vector_integer_T self) -> std::vector< int >::reverse_iterator"},
+	 { "vector_integer_T_clear", _wrap_vector_integer_T_clear, METH_O, "vector_integer_T_clear(vector_integer_T self)"},
+	 { "vector_integer_T_get_allocator", _wrap_vector_integer_T_get_allocator, METH_O, "vector_integer_T_get_allocator(vector_integer_T self) -> std::vector< int >::allocator_type"},
+	 { "vector_integer_T_pop_back", _wrap_vector_integer_T_pop_back, METH_O, "vector_integer_T_pop_back(vector_integer_T self)"},
+	 { "vector_integer_T_erase", _wrap_vector_integer_T_erase, METH_VARARGS, "\n"
+		"vector_integer_T_erase(vector_integer_T self, std::vector< int >::iterator pos) -> std::vector< int >::iterator\n"
+		"vector_integer_T_erase(vector_integer_T self, std::vector< int >::iterator first, std::vector< int >::iterator last) -> std::vector< int >::iterator\n"
 		""},
-	 { "new_vector_integer_t", _wrap_new_vector_integer_t, METH_VARARGS, "\n"
-		"vector_integer_t()\n"
-		"vector_integer_t(vector_integer_t other)\n"
-		"vector_integer_t(std::vector< int >::size_type size)\n"
-		"new_vector_integer_t(std::vector< int >::size_type size, std::vector< int >::value_type const & value) -> vector_integer_t\n"
+	 { "new_vector_integer_T", _wrap_new_vector_integer_T, METH_VARARGS, "\n"
+		"vector_integer_T()\n"
+		"vector_integer_T(vector_integer_T other)\n"
+		"vector_integer_T(std::vector< int >::size_type size)\n"
+		"new_vector_integer_T(std::vector< int >::size_type size, std::vector< int >::value_type const & value) -> vector_integer_T\n"
 		""},
-	 { "vector_integer_t_push_back", _wrap_vector_integer_t_push_back, METH_VARARGS, "vector_integer_t_push_back(vector_integer_t self, std::vector< int >::value_type const & x)"},
-	 { "vector_integer_t_front", _wrap_vector_integer_t_front, METH_O, "vector_integer_t_front(vector_integer_t self) -> std::vector< int >::value_type const &"},
-	 { "vector_integer_t_back", _wrap_vector_integer_t_back, METH_O, "vector_integer_t_back(vector_integer_t self) -> std::vector< int >::value_type const &"},
-	 { "vector_integer_t_assign", _wrap_vector_integer_t_assign, METH_VARARGS, "vector_integer_t_assign(vector_integer_t self, std::vector< int >::size_type n, std::vector< int >::value_type const & x)"},
-	 { "vector_integer_t_resize", _wrap_vector_integer_t_resize, METH_VARARGS, "\n"
-		"vector_integer_t_resize(vector_integer_t self, std::vector< int >::size_type new_size)\n"
-		"vector_integer_t_resize(vector_integer_t self, std::vector< int >::size_type new_size, std::vector< int >::value_type const & x)\n"
+	 { "vector_integer_T_push_back", _wrap_vector_integer_T_push_back, METH_VARARGS, "vector_integer_T_push_back(vector_integer_T self, std::vector< int >::value_type const & x)"},
+	 { "vector_integer_T_front", _wrap_vector_integer_T_front, METH_O, "vector_integer_T_front(vector_integer_T self) -> std::vector< int >::value_type const &"},
+	 { "vector_integer_T_back", _wrap_vector_integer_T_back, METH_O, "vector_integer_T_back(vector_integer_T self) -> std::vector< int >::value_type const &"},
+	 { "vector_integer_T_assign", _wrap_vector_integer_T_assign, METH_VARARGS, "vector_integer_T_assign(vector_integer_T self, std::vector< int >::size_type n, std::vector< int >::value_type const & x)"},
+	 { "vector_integer_T_resize", _wrap_vector_integer_T_resize, METH_VARARGS, "\n"
+		"vector_integer_T_resize(vector_integer_T self, std::vector< int >::size_type new_size)\n"
+		"vector_integer_T_resize(vector_integer_T self, std::vector< int >::size_type new_size, std::vector< int >::value_type const & x)\n"
 		""},
-	 { "vector_integer_t_insert", _wrap_vector_integer_t_insert, METH_VARARGS, "\n"
-		"vector_integer_t_insert(vector_integer_t self, std::vector< int >::iterator pos, std::vector< int >::value_type const & x) -> std::vector< int >::iterator\n"
-		"vector_integer_t_insert(vector_integer_t self, std::vector< int >::iterator pos, std::vector< int >::size_type n, std::vector< int >::value_type const & x)\n"
+	 { "vector_integer_T_insert", _wrap_vector_integer_T_insert, METH_VARARGS, "\n"
+		"vector_integer_T_insert(vector_integer_T self, std::vector< int >::iterator pos, std::vector< int >::value_type const & x) -> std::vector< int >::iterator\n"
+		"vector_integer_T_insert(vector_integer_T self, std::vector< int >::iterator pos, std::vector< int >::size_type n, std::vector< int >::value_type const & x)\n"
 		""},
-	 { "vector_integer_t_reserve", _wrap_vector_integer_t_reserve, METH_VARARGS, "vector_integer_t_reserve(vector_integer_t self, std::vector< int >::size_type n)"},
-	 { "vector_integer_t_capacity", _wrap_vector_integer_t_capacity, METH_O, "vector_integer_t_capacity(vector_integer_t self) -> std::vector< int >::size_type"},
-	 { "delete_vector_integer_t", _wrap_delete_vector_integer_t, METH_O, "delete_vector_integer_t(vector_integer_t self)"},
-	 { "vector_integer_t_swigregister", vector_integer_t_swigregister, METH_O, NULL},
-	 { "vector_integer_t_swiginit", vector_integer_t_swiginit, METH_VARARGS, NULL},
-	 { "vinteger2d_t_iterator", _wrap_vinteger2d_t_iterator, METH_O, "vinteger2d_t_iterator(vinteger2d_t self) -> SwigPyIterator"},
-	 { "vinteger2d_t___nonzero__", _wrap_vinteger2d_t___nonzero__, METH_O, "vinteger2d_t___nonzero__(vinteger2d_t self) -> bool"},
-	 { "vinteger2d_t___bool__", _wrap_vinteger2d_t___bool__, METH_O, "vinteger2d_t___bool__(vinteger2d_t self) -> bool"},
-	 { "vinteger2d_t___len__", _wrap_vinteger2d_t___len__, METH_O, "vinteger2d_t___len__(vinteger2d_t self) -> std::vector< std::vector< int > >::size_type"},
-	 { "vinteger2d_t___getslice__", _wrap_vinteger2d_t___getslice__, METH_VARARGS, "vinteger2d_t___getslice__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j) -> vinteger2d_t"},
-	 { "vinteger2d_t___setslice__", _wrap_vinteger2d_t___setslice__, METH_VARARGS, "\n"
-		"vinteger2d_t___setslice__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j)\n"
-		"vinteger2d_t___setslice__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j, vinteger2d_t v)\n"
+	 { "vector_integer_T_reserve", _wrap_vector_integer_T_reserve, METH_VARARGS, "vector_integer_T_reserve(vector_integer_T self, std::vector< int >::size_type n)"},
+	 { "vector_integer_T_capacity", _wrap_vector_integer_T_capacity, METH_O, "vector_integer_T_capacity(vector_integer_T self) -> std::vector< int >::size_type"},
+	 { "delete_vector_integer_T", _wrap_delete_vector_integer_T, METH_O, "delete_vector_integer_T(vector_integer_T self)"},
+	 { "vector_integer_T_swigregister", vector_integer_T_swigregister, METH_O, NULL},
+	 { "vector_integer_T_swiginit", vector_integer_T_swiginit, METH_VARARGS, NULL},
+	 { "vinteger2d_T_iterator", _wrap_vinteger2d_T_iterator, METH_O, "vinteger2d_T_iterator(vinteger2d_T self) -> SwigPyIterator"},
+	 { "vinteger2d_T___nonzero__", _wrap_vinteger2d_T___nonzero__, METH_O, "vinteger2d_T___nonzero__(vinteger2d_T self) -> bool"},
+	 { "vinteger2d_T___bool__", _wrap_vinteger2d_T___bool__, METH_O, "vinteger2d_T___bool__(vinteger2d_T self) -> bool"},
+	 { "vinteger2d_T___len__", _wrap_vinteger2d_T___len__, METH_O, "vinteger2d_T___len__(vinteger2d_T self) -> std::vector< std::vector< int > >::size_type"},
+	 { "vinteger2d_T___getslice__", _wrap_vinteger2d_T___getslice__, METH_VARARGS, "vinteger2d_T___getslice__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j) -> vinteger2d_T"},
+	 { "vinteger2d_T___setslice__", _wrap_vinteger2d_T___setslice__, METH_VARARGS, "\n"
+		"vinteger2d_T___setslice__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j)\n"
+		"vinteger2d_T___setslice__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j, vinteger2d_T v)\n"
 		""},
-	 { "vinteger2d_t___delslice__", _wrap_vinteger2d_t___delslice__, METH_VARARGS, "vinteger2d_t___delslice__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j)"},
-	 { "vinteger2d_t___delitem__", _wrap_vinteger2d_t___delitem__, METH_VARARGS, "\n"
-		"vinteger2d_t___delitem__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i)\n"
-		"vinteger2d_t___delitem__(vinteger2d_t self, SWIGPY_SLICEOBJECT * slice)\n"
+	 { "vinteger2d_T___delslice__", _wrap_vinteger2d_T___delslice__, METH_VARARGS, "vinteger2d_T___delslice__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j)"},
+	 { "vinteger2d_T___delitem__", _wrap_vinteger2d_T___delitem__, METH_VARARGS, "\n"
+		"vinteger2d_T___delitem__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i)\n"
+		"vinteger2d_T___delitem__(vinteger2d_T self, SWIGPY_SLICEOBJECT * slice)\n"
 		""},
-	 { "vinteger2d_t___getitem__", _wrap_vinteger2d_t___getitem__, METH_VARARGS, "\n"
-		"vinteger2d_t___getitem__(vinteger2d_t self, SWIGPY_SLICEOBJECT * slice) -> vinteger2d_t\n"
-		"vinteger2d_t___getitem__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i) -> vector_integer_t\n"
+	 { "vinteger2d_T___getitem__", _wrap_vinteger2d_T___getitem__, METH_VARARGS, "\n"
+		"vinteger2d_T___getitem__(vinteger2d_T self, SWIGPY_SLICEOBJECT * slice) -> vinteger2d_T\n"
+		"vinteger2d_T___getitem__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i) -> vector_integer_T\n"
 		""},
-	 { "vinteger2d_t___setitem__", _wrap_vinteger2d_t___setitem__, METH_VARARGS, "\n"
-		"vinteger2d_t___setitem__(vinteger2d_t self, SWIGPY_SLICEOBJECT * slice, vinteger2d_t v)\n"
-		"vinteger2d_t___setitem__(vinteger2d_t self, SWIGPY_SLICEOBJECT * slice)\n"
-		"vinteger2d_t___setitem__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i, vector_integer_t x)\n"
+	 { "vinteger2d_T___setitem__", _wrap_vinteger2d_T___setitem__, METH_VARARGS, "\n"
+		"vinteger2d_T___setitem__(vinteger2d_T self, SWIGPY_SLICEOBJECT * slice, vinteger2d_T v)\n"
+		"vinteger2d_T___setitem__(vinteger2d_T self, SWIGPY_SLICEOBJECT * slice)\n"
+		"vinteger2d_T___setitem__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i, vector_integer_T x)\n"
 		""},
-	 { "vinteger2d_t_pop", _wrap_vinteger2d_t_pop, METH_O, "vinteger2d_t_pop(vinteger2d_t self) -> vector_integer_t"},
-	 { "vinteger2d_t_append", _wrap_vinteger2d_t_append, METH_VARARGS, "vinteger2d_t_append(vinteger2d_t self, vector_integer_t x)"},
-	 { "vinteger2d_t_empty", _wrap_vinteger2d_t_empty, METH_O, "vinteger2d_t_empty(vinteger2d_t self) -> bool"},
-	 { "vinteger2d_t_size", _wrap_vinteger2d_t_size, METH_O, "vinteger2d_t_size(vinteger2d_t self) -> std::vector< std::vector< int > >::size_type"},
-	 { "vinteger2d_t_swap", _wrap_vinteger2d_t_swap, METH_VARARGS, "vinteger2d_t_swap(vinteger2d_t self, vinteger2d_t v)"},
-	 { "vinteger2d_t_begin", _wrap_vinteger2d_t_begin, METH_O, "vinteger2d_t_begin(vinteger2d_t self) -> std::vector< std::vector< int > >::iterator"},
-	 { "vinteger2d_t_end", _wrap_vinteger2d_t_end, METH_O, "vinteger2d_t_end(vinteger2d_t self) -> std::vector< std::vector< int > >::iterator"},
-	 { "vinteger2d_t_rbegin", _wrap_vinteger2d_t_rbegin, METH_O, "vinteger2d_t_rbegin(vinteger2d_t self) -> std::vector< std::vector< int > >::reverse_iterator"},
-	 { "vinteger2d_t_rend", _wrap_vinteger2d_t_rend, METH_O, "vinteger2d_t_rend(vinteger2d_t self) -> std::vector< std::vector< int > >::reverse_iterator"},
-	 { "vinteger2d_t_clear", _wrap_vinteger2d_t_clear, METH_O, "vinteger2d_t_clear(vinteger2d_t self)"},
-	 { "vinteger2d_t_get_allocator", _wrap_vinteger2d_t_get_allocator, METH_O, "vinteger2d_t_get_allocator(vinteger2d_t self) -> std::vector< std::vector< int > >::allocator_type"},
-	 { "vinteger2d_t_pop_back", _wrap_vinteger2d_t_pop_back, METH_O, "vinteger2d_t_pop_back(vinteger2d_t self)"},
-	 { "vinteger2d_t_erase", _wrap_vinteger2d_t_erase, METH_VARARGS, "\n"
-		"vinteger2d_t_erase(vinteger2d_t self, std::vector< std::vector< int > >::iterator pos) -> std::vector< std::vector< int > >::iterator\n"
-		"vinteger2d_t_erase(vinteger2d_t self, std::vector< std::vector< int > >::iterator first, std::vector< std::vector< int > >::iterator last) -> std::vector< std::vector< int > >::iterator\n"
+	 { "vinteger2d_T_pop", _wrap_vinteger2d_T_pop, METH_O, "vinteger2d_T_pop(vinteger2d_T self) -> vector_integer_T"},
+	 { "vinteger2d_T_append", _wrap_vinteger2d_T_append, METH_VARARGS, "vinteger2d_T_append(vinteger2d_T self, vector_integer_T x)"},
+	 { "vinteger2d_T_empty", _wrap_vinteger2d_T_empty, METH_O, "vinteger2d_T_empty(vinteger2d_T self) -> bool"},
+	 { "vinteger2d_T_size", _wrap_vinteger2d_T_size, METH_O, "vinteger2d_T_size(vinteger2d_T self) -> std::vector< std::vector< int > >::size_type"},
+	 { "vinteger2d_T_swap", _wrap_vinteger2d_T_swap, METH_VARARGS, "vinteger2d_T_swap(vinteger2d_T self, vinteger2d_T v)"},
+	 { "vinteger2d_T_begin", _wrap_vinteger2d_T_begin, METH_O, "vinteger2d_T_begin(vinteger2d_T self) -> std::vector< std::vector< int > >::iterator"},
+	 { "vinteger2d_T_end", _wrap_vinteger2d_T_end, METH_O, "vinteger2d_T_end(vinteger2d_T self) -> std::vector< std::vector< int > >::iterator"},
+	 { "vinteger2d_T_rbegin", _wrap_vinteger2d_T_rbegin, METH_O, "vinteger2d_T_rbegin(vinteger2d_T self) -> std::vector< std::vector< int > >::reverse_iterator"},
+	 { "vinteger2d_T_rend", _wrap_vinteger2d_T_rend, METH_O, "vinteger2d_T_rend(vinteger2d_T self) -> std::vector< std::vector< int > >::reverse_iterator"},
+	 { "vinteger2d_T_clear", _wrap_vinteger2d_T_clear, METH_O, "vinteger2d_T_clear(vinteger2d_T self)"},
+	 { "vinteger2d_T_get_allocator", _wrap_vinteger2d_T_get_allocator, METH_O, "vinteger2d_T_get_allocator(vinteger2d_T self) -> std::vector< std::vector< int > >::allocator_type"},
+	 { "vinteger2d_T_pop_back", _wrap_vinteger2d_T_pop_back, METH_O, "vinteger2d_T_pop_back(vinteger2d_T self)"},
+	 { "vinteger2d_T_erase", _wrap_vinteger2d_T_erase, METH_VARARGS, "\n"
+		"vinteger2d_T_erase(vinteger2d_T self, std::vector< std::vector< int > >::iterator pos) -> std::vector< std::vector< int > >::iterator\n"
+		"vinteger2d_T_erase(vinteger2d_T self, std::vector< std::vector< int > >::iterator first, std::vector< std::vector< int > >::iterator last) -> std::vector< std::vector< int > >::iterator\n"
 		""},
-	 { "new_vinteger2d_t", _wrap_new_vinteger2d_t, METH_VARARGS, "\n"
-		"vinteger2d_t()\n"
-		"vinteger2d_t(vinteger2d_t other)\n"
-		"vinteger2d_t(std::vector< std::vector< int > >::size_type size)\n"
-		"new_vinteger2d_t(std::vector< std::vector< int > >::size_type size, vector_integer_t value) -> vinteger2d_t\n"
+	 { "new_vinteger2d_T", _wrap_new_vinteger2d_T, METH_VARARGS, "\n"
+		"vinteger2d_T()\n"
+		"vinteger2d_T(vinteger2d_T other)\n"
+		"vinteger2d_T(std::vector< std::vector< int > >::size_type size)\n"
+		"new_vinteger2d_T(std::vector< std::vector< int > >::size_type size, vector_integer_T value) -> vinteger2d_T\n"
 		""},
-	 { "vinteger2d_t_push_back", _wrap_vinteger2d_t_push_back, METH_VARARGS, "vinteger2d_t_push_back(vinteger2d_t self, vector_integer_t x)"},
-	 { "vinteger2d_t_front", _wrap_vinteger2d_t_front, METH_O, "vinteger2d_t_front(vinteger2d_t self) -> vector_integer_t"},
-	 { "vinteger2d_t_back", _wrap_vinteger2d_t_back, METH_O, "vinteger2d_t_back(vinteger2d_t self) -> vector_integer_t"},
-	 { "vinteger2d_t_assign", _wrap_vinteger2d_t_assign, METH_VARARGS, "vinteger2d_t_assign(vinteger2d_t self, std::vector< std::vector< int > >::size_type n, vector_integer_t x)"},
-	 { "vinteger2d_t_resize", _wrap_vinteger2d_t_resize, METH_VARARGS, "\n"
-		"vinteger2d_t_resize(vinteger2d_t self, std::vector< std::vector< int > >::size_type new_size)\n"
-		"vinteger2d_t_resize(vinteger2d_t self, std::vector< std::vector< int > >::size_type new_size, vector_integer_t x)\n"
+	 { "vinteger2d_T_push_back", _wrap_vinteger2d_T_push_back, METH_VARARGS, "vinteger2d_T_push_back(vinteger2d_T self, vector_integer_T x)"},
+	 { "vinteger2d_T_front", _wrap_vinteger2d_T_front, METH_O, "vinteger2d_T_front(vinteger2d_T self) -> vector_integer_T"},
+	 { "vinteger2d_T_back", _wrap_vinteger2d_T_back, METH_O, "vinteger2d_T_back(vinteger2d_T self) -> vector_integer_T"},
+	 { "vinteger2d_T_assign", _wrap_vinteger2d_T_assign, METH_VARARGS, "vinteger2d_T_assign(vinteger2d_T self, std::vector< std::vector< int > >::size_type n, vector_integer_T x)"},
+	 { "vinteger2d_T_resize", _wrap_vinteger2d_T_resize, METH_VARARGS, "\n"
+		"vinteger2d_T_resize(vinteger2d_T self, std::vector< std::vector< int > >::size_type new_size)\n"
+		"vinteger2d_T_resize(vinteger2d_T self, std::vector< std::vector< int > >::size_type new_size, vector_integer_T x)\n"
 		""},
-	 { "vinteger2d_t_insert", _wrap_vinteger2d_t_insert, METH_VARARGS, "\n"
-		"vinteger2d_t_insert(vinteger2d_t self, std::vector< std::vector< int > >::iterator pos, vector_integer_t x) -> std::vector< std::vector< int > >::iterator\n"
-		"vinteger2d_t_insert(vinteger2d_t self, std::vector< std::vector< int > >::iterator pos, std::vector< std::vector< int > >::size_type n, vector_integer_t x)\n"
+	 { "vinteger2d_T_insert", _wrap_vinteger2d_T_insert, METH_VARARGS, "\n"
+		"vinteger2d_T_insert(vinteger2d_T self, std::vector< std::vector< int > >::iterator pos, vector_integer_T x) -> std::vector< std::vector< int > >::iterator\n"
+		"vinteger2d_T_insert(vinteger2d_T self, std::vector< std::vector< int > >::iterator pos, std::vector< std::vector< int > >::size_type n, vector_integer_T x)\n"
 		""},
-	 { "vinteger2d_t_reserve", _wrap_vinteger2d_t_reserve, METH_VARARGS, "vinteger2d_t_reserve(vinteger2d_t self, std::vector< std::vector< int > >::size_type n)"},
-	 { "vinteger2d_t_capacity", _wrap_vinteger2d_t_capacity, METH_O, "vinteger2d_t_capacity(vinteger2d_t self) -> std::vector< std::vector< int > >::size_type"},
-	 { "delete_vinteger2d_t", _wrap_delete_vinteger2d_t, METH_O, "delete_vinteger2d_t(vinteger2d_t self)"},
-	 { "vinteger2d_t_swigregister", vinteger2d_t_swigregister, METH_O, NULL},
-	 { "vinteger2d_t_swiginit", vinteger2d_t_swiginit, METH_VARARGS, NULL},
-	 { "vector_longinteger_t_iterator", _wrap_vector_longinteger_t_iterator, METH_O, "vector_longinteger_t_iterator(vector_longinteger_t self) -> SwigPyIterator"},
-	 { "vector_longinteger_t___nonzero__", _wrap_vector_longinteger_t___nonzero__, METH_O, "vector_longinteger_t___nonzero__(vector_longinteger_t self) -> bool"},
-	 { "vector_longinteger_t___bool__", _wrap_vector_longinteger_t___bool__, METH_O, "vector_longinteger_t___bool__(vector_longinteger_t self) -> bool"},
-	 { "vector_longinteger_t___len__", _wrap_vector_longinteger_t___len__, METH_O, "vector_longinteger_t___len__(vector_longinteger_t self) -> std::vector< unsigned long >::size_type"},
-	 { "vector_longinteger_t___getslice__", _wrap_vector_longinteger_t___getslice__, METH_VARARGS, "vector_longinteger_t___getslice__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j) -> vector_longinteger_t"},
-	 { "vector_longinteger_t___setslice__", _wrap_vector_longinteger_t___setslice__, METH_VARARGS, "\n"
-		"vector_longinteger_t___setslice__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j)\n"
-		"vector_longinteger_t___setslice__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j, vector_longinteger_t v)\n"
+	 { "vinteger2d_T_reserve", _wrap_vinteger2d_T_reserve, METH_VARARGS, "vinteger2d_T_reserve(vinteger2d_T self, std::vector< std::vector< int > >::size_type n)"},
+	 { "vinteger2d_T_capacity", _wrap_vinteger2d_T_capacity, METH_O, "vinteger2d_T_capacity(vinteger2d_T self) -> std::vector< std::vector< int > >::size_type"},
+	 { "delete_vinteger2d_T", _wrap_delete_vinteger2d_T, METH_O, "delete_vinteger2d_T(vinteger2d_T self)"},
+	 { "vinteger2d_T_swigregister", vinteger2d_T_swigregister, METH_O, NULL},
+	 { "vinteger2d_T_swiginit", vinteger2d_T_swiginit, METH_VARARGS, NULL},
+	 { "vector_longinteger_T_iterator", _wrap_vector_longinteger_T_iterator, METH_O, "vector_longinteger_T_iterator(vector_longinteger_T self) -> SwigPyIterator"},
+	 { "vector_longinteger_T___nonzero__", _wrap_vector_longinteger_T___nonzero__, METH_O, "vector_longinteger_T___nonzero__(vector_longinteger_T self) -> bool"},
+	 { "vector_longinteger_T___bool__", _wrap_vector_longinteger_T___bool__, METH_O, "vector_longinteger_T___bool__(vector_longinteger_T self) -> bool"},
+	 { "vector_longinteger_T___len__", _wrap_vector_longinteger_T___len__, METH_O, "vector_longinteger_T___len__(vector_longinteger_T self) -> std::vector< unsigned long >::size_type"},
+	 { "vector_longinteger_T___getslice__", _wrap_vector_longinteger_T___getslice__, METH_VARARGS, "vector_longinteger_T___getslice__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j) -> vector_longinteger_T"},
+	 { "vector_longinteger_T___setslice__", _wrap_vector_longinteger_T___setslice__, METH_VARARGS, "\n"
+		"vector_longinteger_T___setslice__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j)\n"
+		"vector_longinteger_T___setslice__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j, vector_longinteger_T v)\n"
 		""},
-	 { "vector_longinteger_t___delslice__", _wrap_vector_longinteger_t___delslice__, METH_VARARGS, "vector_longinteger_t___delslice__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j)"},
-	 { "vector_longinteger_t___delitem__", _wrap_vector_longinteger_t___delitem__, METH_VARARGS, "\n"
-		"vector_longinteger_t___delitem__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i)\n"
-		"vector_longinteger_t___delitem__(vector_longinteger_t self, SWIGPY_SLICEOBJECT * slice)\n"
+	 { "vector_longinteger_T___delslice__", _wrap_vector_longinteger_T___delslice__, METH_VARARGS, "vector_longinteger_T___delslice__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j)"},
+	 { "vector_longinteger_T___delitem__", _wrap_vector_longinteger_T___delitem__, METH_VARARGS, "\n"
+		"vector_longinteger_T___delitem__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i)\n"
+		"vector_longinteger_T___delitem__(vector_longinteger_T self, SWIGPY_SLICEOBJECT * slice)\n"
 		""},
-	 { "vector_longinteger_t___getitem__", _wrap_vector_longinteger_t___getitem__, METH_VARARGS, "\n"
-		"vector_longinteger_t___getitem__(vector_longinteger_t self, SWIGPY_SLICEOBJECT * slice) -> vector_longinteger_t\n"
-		"vector_longinteger_t___getitem__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i) -> std::vector< unsigned long >::value_type const &\n"
+	 { "vector_longinteger_T___getitem__", _wrap_vector_longinteger_T___getitem__, METH_VARARGS, "\n"
+		"vector_longinteger_T___getitem__(vector_longinteger_T self, SWIGPY_SLICEOBJECT * slice) -> vector_longinteger_T\n"
+		"vector_longinteger_T___getitem__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i) -> std::vector< unsigned long >::value_type const &\n"
 		""},
-	 { "vector_longinteger_t___setitem__", _wrap_vector_longinteger_t___setitem__, METH_VARARGS, "\n"
-		"vector_longinteger_t___setitem__(vector_longinteger_t self, SWIGPY_SLICEOBJECT * slice, vector_longinteger_t v)\n"
-		"vector_longinteger_t___setitem__(vector_longinteger_t self, SWIGPY_SLICEOBJECT * slice)\n"
-		"vector_longinteger_t___setitem__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::value_type const & x)\n"
+	 { "vector_longinteger_T___setitem__", _wrap_vector_longinteger_T___setitem__, METH_VARARGS, "\n"
+		"vector_longinteger_T___setitem__(vector_longinteger_T self, SWIGPY_SLICEOBJECT * slice, vector_longinteger_T v)\n"
+		"vector_longinteger_T___setitem__(vector_longinteger_T self, SWIGPY_SLICEOBJECT * slice)\n"
+		"vector_longinteger_T___setitem__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::value_type const & x)\n"
 		""},
-	 { "vector_longinteger_t_pop", _wrap_vector_longinteger_t_pop, METH_O, "vector_longinteger_t_pop(vector_longinteger_t self) -> std::vector< unsigned long >::value_type"},
-	 { "vector_longinteger_t_append", _wrap_vector_longinteger_t_append, METH_VARARGS, "vector_longinteger_t_append(vector_longinteger_t self, std::vector< unsigned long >::value_type const & x)"},
-	 { "vector_longinteger_t_empty", _wrap_vector_longinteger_t_empty, METH_O, "vector_longinteger_t_empty(vector_longinteger_t self) -> bool"},
-	 { "vector_longinteger_t_size", _wrap_vector_longinteger_t_size, METH_O, "vector_longinteger_t_size(vector_longinteger_t self) -> std::vector< unsigned long >::size_type"},
-	 { "vector_longinteger_t_swap", _wrap_vector_longinteger_t_swap, METH_VARARGS, "vector_longinteger_t_swap(vector_longinteger_t self, vector_longinteger_t v)"},
-	 { "vector_longinteger_t_begin", _wrap_vector_longinteger_t_begin, METH_O, "vector_longinteger_t_begin(vector_longinteger_t self) -> std::vector< unsigned long >::iterator"},
-	 { "vector_longinteger_t_end", _wrap_vector_longinteger_t_end, METH_O, "vector_longinteger_t_end(vector_longinteger_t self) -> std::vector< unsigned long >::iterator"},
-	 { "vector_longinteger_t_rbegin", _wrap_vector_longinteger_t_rbegin, METH_O, "vector_longinteger_t_rbegin(vector_longinteger_t self) -> std::vector< unsigned long >::reverse_iterator"},
-	 { "vector_longinteger_t_rend", _wrap_vector_longinteger_t_rend, METH_O, "vector_longinteger_t_rend(vector_longinteger_t self) -> std::vector< unsigned long >::reverse_iterator"},
-	 { "vector_longinteger_t_clear", _wrap_vector_longinteger_t_clear, METH_O, "vector_longinteger_t_clear(vector_longinteger_t self)"},
-	 { "vector_longinteger_t_get_allocator", _wrap_vector_longinteger_t_get_allocator, METH_O, "vector_longinteger_t_get_allocator(vector_longinteger_t self) -> std::vector< unsigned long >::allocator_type"},
-	 { "vector_longinteger_t_pop_back", _wrap_vector_longinteger_t_pop_back, METH_O, "vector_longinteger_t_pop_back(vector_longinteger_t self)"},
-	 { "vector_longinteger_t_erase", _wrap_vector_longinteger_t_erase, METH_VARARGS, "\n"
-		"vector_longinteger_t_erase(vector_longinteger_t self, std::vector< unsigned long >::iterator pos) -> std::vector< unsigned long >::iterator\n"
-		"vector_longinteger_t_erase(vector_longinteger_t self, std::vector< unsigned long >::iterator first, std::vector< unsigned long >::iterator last) -> std::vector< unsigned long >::iterator\n"
+	 { "vector_longinteger_T_pop", _wrap_vector_longinteger_T_pop, METH_O, "vector_longinteger_T_pop(vector_longinteger_T self) -> std::vector< unsigned long >::value_type"},
+	 { "vector_longinteger_T_append", _wrap_vector_longinteger_T_append, METH_VARARGS, "vector_longinteger_T_append(vector_longinteger_T self, std::vector< unsigned long >::value_type const & x)"},
+	 { "vector_longinteger_T_empty", _wrap_vector_longinteger_T_empty, METH_O, "vector_longinteger_T_empty(vector_longinteger_T self) -> bool"},
+	 { "vector_longinteger_T_size", _wrap_vector_longinteger_T_size, METH_O, "vector_longinteger_T_size(vector_longinteger_T self) -> std::vector< unsigned long >::size_type"},
+	 { "vector_longinteger_T_swap", _wrap_vector_longinteger_T_swap, METH_VARARGS, "vector_longinteger_T_swap(vector_longinteger_T self, vector_longinteger_T v)"},
+	 { "vector_longinteger_T_begin", _wrap_vector_longinteger_T_begin, METH_O, "vector_longinteger_T_begin(vector_longinteger_T self) -> std::vector< unsigned long >::iterator"},
+	 { "vector_longinteger_T_end", _wrap_vector_longinteger_T_end, METH_O, "vector_longinteger_T_end(vector_longinteger_T self) -> std::vector< unsigned long >::iterator"},
+	 { "vector_longinteger_T_rbegin", _wrap_vector_longinteger_T_rbegin, METH_O, "vector_longinteger_T_rbegin(vector_longinteger_T self) -> std::vector< unsigned long >::reverse_iterator"},
+	 { "vector_longinteger_T_rend", _wrap_vector_longinteger_T_rend, METH_O, "vector_longinteger_T_rend(vector_longinteger_T self) -> std::vector< unsigned long >::reverse_iterator"},
+	 { "vector_longinteger_T_clear", _wrap_vector_longinteger_T_clear, METH_O, "vector_longinteger_T_clear(vector_longinteger_T self)"},
+	 { "vector_longinteger_T_get_allocator", _wrap_vector_longinteger_T_get_allocator, METH_O, "vector_longinteger_T_get_allocator(vector_longinteger_T self) -> std::vector< unsigned long >::allocator_type"},
+	 { "vector_longinteger_T_pop_back", _wrap_vector_longinteger_T_pop_back, METH_O, "vector_longinteger_T_pop_back(vector_longinteger_T self)"},
+	 { "vector_longinteger_T_erase", _wrap_vector_longinteger_T_erase, METH_VARARGS, "\n"
+		"vector_longinteger_T_erase(vector_longinteger_T self, std::vector< unsigned long >::iterator pos) -> std::vector< unsigned long >::iterator\n"
+		"vector_longinteger_T_erase(vector_longinteger_T self, std::vector< unsigned long >::iterator first, std::vector< unsigned long >::iterator last) -> std::vector< unsigned long >::iterator\n"
 		""},
-	 { "new_vector_longinteger_t", _wrap_new_vector_longinteger_t, METH_VARARGS, "\n"
-		"vector_longinteger_t()\n"
-		"vector_longinteger_t(vector_longinteger_t other)\n"
-		"vector_longinteger_t(std::vector< unsigned long >::size_type size)\n"
-		"new_vector_longinteger_t(std::vector< unsigned long >::size_type size, std::vector< unsigned long >::value_type const & value) -> vector_longinteger_t\n"
+	 { "new_vector_longinteger_T", _wrap_new_vector_longinteger_T, METH_VARARGS, "\n"
+		"vector_longinteger_T()\n"
+		"vector_longinteger_T(vector_longinteger_T other)\n"
+		"vector_longinteger_T(std::vector< unsigned long >::size_type size)\n"
+		"new_vector_longinteger_T(std::vector< unsigned long >::size_type size, std::vector< unsigned long >::value_type const & value) -> vector_longinteger_T\n"
 		""},
-	 { "vector_longinteger_t_push_back", _wrap_vector_longinteger_t_push_back, METH_VARARGS, "vector_longinteger_t_push_back(vector_longinteger_t self, std::vector< unsigned long >::value_type const & x)"},
-	 { "vector_longinteger_t_front", _wrap_vector_longinteger_t_front, METH_O, "vector_longinteger_t_front(vector_longinteger_t self) -> std::vector< unsigned long >::value_type const &"},
-	 { "vector_longinteger_t_back", _wrap_vector_longinteger_t_back, METH_O, "vector_longinteger_t_back(vector_longinteger_t self) -> std::vector< unsigned long >::value_type const &"},
-	 { "vector_longinteger_t_assign", _wrap_vector_longinteger_t_assign, METH_VARARGS, "vector_longinteger_t_assign(vector_longinteger_t self, std::vector< unsigned long >::size_type n, std::vector< unsigned long >::value_type const & x)"},
-	 { "vector_longinteger_t_resize", _wrap_vector_longinteger_t_resize, METH_VARARGS, "\n"
-		"vector_longinteger_t_resize(vector_longinteger_t self, std::vector< unsigned long >::size_type new_size)\n"
-		"vector_longinteger_t_resize(vector_longinteger_t self, std::vector< unsigned long >::size_type new_size, std::vector< unsigned long >::value_type const & x)\n"
+	 { "vector_longinteger_T_push_back", _wrap_vector_longinteger_T_push_back, METH_VARARGS, "vector_longinteger_T_push_back(vector_longinteger_T self, std::vector< unsigned long >::value_type const & x)"},
+	 { "vector_longinteger_T_front", _wrap_vector_longinteger_T_front, METH_O, "vector_longinteger_T_front(vector_longinteger_T self) -> std::vector< unsigned long >::value_type const &"},
+	 { "vector_longinteger_T_back", _wrap_vector_longinteger_T_back, METH_O, "vector_longinteger_T_back(vector_longinteger_T self) -> std::vector< unsigned long >::value_type const &"},
+	 { "vector_longinteger_T_assign", _wrap_vector_longinteger_T_assign, METH_VARARGS, "vector_longinteger_T_assign(vector_longinteger_T self, std::vector< unsigned long >::size_type n, std::vector< unsigned long >::value_type const & x)"},
+	 { "vector_longinteger_T_resize", _wrap_vector_longinteger_T_resize, METH_VARARGS, "\n"
+		"vector_longinteger_T_resize(vector_longinteger_T self, std::vector< unsigned long >::size_type new_size)\n"
+		"vector_longinteger_T_resize(vector_longinteger_T self, std::vector< unsigned long >::size_type new_size, std::vector< unsigned long >::value_type const & x)\n"
 		""},
-	 { "vector_longinteger_t_insert", _wrap_vector_longinteger_t_insert, METH_VARARGS, "\n"
-		"vector_longinteger_t_insert(vector_longinteger_t self, std::vector< unsigned long >::iterator pos, std::vector< unsigned long >::value_type const & x) -> std::vector< unsigned long >::iterator\n"
-		"vector_longinteger_t_insert(vector_longinteger_t self, std::vector< unsigned long >::iterator pos, std::vector< unsigned long >::size_type n, std::vector< unsigned long >::value_type const & x)\n"
+	 { "vector_longinteger_T_insert", _wrap_vector_longinteger_T_insert, METH_VARARGS, "\n"
+		"vector_longinteger_T_insert(vector_longinteger_T self, std::vector< unsigned long >::iterator pos, std::vector< unsigned long >::value_type const & x) -> std::vector< unsigned long >::iterator\n"
+		"vector_longinteger_T_insert(vector_longinteger_T self, std::vector< unsigned long >::iterator pos, std::vector< unsigned long >::size_type n, std::vector< unsigned long >::value_type const & x)\n"
 		""},
-	 { "vector_longinteger_t_reserve", _wrap_vector_longinteger_t_reserve, METH_VARARGS, "vector_longinteger_t_reserve(vector_longinteger_t self, std::vector< unsigned long >::size_type n)"},
-	 { "vector_longinteger_t_capacity", _wrap_vector_longinteger_t_capacity, METH_O, "vector_longinteger_t_capacity(vector_longinteger_t self) -> std::vector< unsigned long >::size_type"},
-	 { "delete_vector_longinteger_t", _wrap_delete_vector_longinteger_t, METH_O, "delete_vector_longinteger_t(vector_longinteger_t self)"},
-	 { "vector_longinteger_t_swigregister", vector_longinteger_t_swigregister, METH_O, NULL},
-	 { "vector_longinteger_t_swiginit", vector_longinteger_t_swiginit, METH_VARARGS, NULL},
-	 { "vector_complex_t_iterator", _wrap_vector_complex_t_iterator, METH_O, "vector_complex_t_iterator(vector_complex_t self) -> SwigPyIterator"},
-	 { "vector_complex_t___nonzero__", _wrap_vector_complex_t___nonzero__, METH_O, "vector_complex_t___nonzero__(vector_complex_t self) -> bool"},
-	 { "vector_complex_t___bool__", _wrap_vector_complex_t___bool__, METH_O, "vector_complex_t___bool__(vector_complex_t self) -> bool"},
-	 { "vector_complex_t___len__", _wrap_vector_complex_t___len__, METH_O, "vector_complex_t___len__(vector_complex_t self) -> std::vector< std::complex< double > >::size_type"},
-	 { "vector_complex_t___getslice__", _wrap_vector_complex_t___getslice__, METH_VARARGS, "vector_complex_t___getslice__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j) -> vector_complex_t"},
-	 { "vector_complex_t___setslice__", _wrap_vector_complex_t___setslice__, METH_VARARGS, "\n"
-		"vector_complex_t___setslice__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j)\n"
-		"vector_complex_t___setslice__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j, vector_complex_t v)\n"
+	 { "vector_longinteger_T_reserve", _wrap_vector_longinteger_T_reserve, METH_VARARGS, "vector_longinteger_T_reserve(vector_longinteger_T self, std::vector< unsigned long >::size_type n)"},
+	 { "vector_longinteger_T_capacity", _wrap_vector_longinteger_T_capacity, METH_O, "vector_longinteger_T_capacity(vector_longinteger_T self) -> std::vector< unsigned long >::size_type"},
+	 { "delete_vector_longinteger_T", _wrap_delete_vector_longinteger_T, METH_O, "delete_vector_longinteger_T(vector_longinteger_T self)"},
+	 { "vector_longinteger_T_swigregister", vector_longinteger_T_swigregister, METH_O, NULL},
+	 { "vector_longinteger_T_swiginit", vector_longinteger_T_swiginit, METH_VARARGS, NULL},
+	 { "vector_complex_T_iterator", _wrap_vector_complex_T_iterator, METH_O, "vector_complex_T_iterator(vector_complex_T self) -> SwigPyIterator"},
+	 { "vector_complex_T___nonzero__", _wrap_vector_complex_T___nonzero__, METH_O, "vector_complex_T___nonzero__(vector_complex_T self) -> bool"},
+	 { "vector_complex_T___bool__", _wrap_vector_complex_T___bool__, METH_O, "vector_complex_T___bool__(vector_complex_T self) -> bool"},
+	 { "vector_complex_T___len__", _wrap_vector_complex_T___len__, METH_O, "vector_complex_T___len__(vector_complex_T self) -> std::vector< std::complex< double > >::size_type"},
+	 { "vector_complex_T___getslice__", _wrap_vector_complex_T___getslice__, METH_VARARGS, "vector_complex_T___getslice__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j) -> vector_complex_T"},
+	 { "vector_complex_T___setslice__", _wrap_vector_complex_T___setslice__, METH_VARARGS, "\n"
+		"vector_complex_T___setslice__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j)\n"
+		"vector_complex_T___setslice__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j, vector_complex_T v)\n"
 		""},
-	 { "vector_complex_t___delslice__", _wrap_vector_complex_t___delslice__, METH_VARARGS, "vector_complex_t___delslice__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j)"},
-	 { "vector_complex_t___delitem__", _wrap_vector_complex_t___delitem__, METH_VARARGS, "\n"
-		"vector_complex_t___delitem__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i)\n"
-		"vector_complex_t___delitem__(vector_complex_t self, SWIGPY_SLICEOBJECT * slice)\n"
+	 { "vector_complex_T___delslice__", _wrap_vector_complex_T___delslice__, METH_VARARGS, "vector_complex_T___delslice__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j)"},
+	 { "vector_complex_T___delitem__", _wrap_vector_complex_T___delitem__, METH_VARARGS, "\n"
+		"vector_complex_T___delitem__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i)\n"
+		"vector_complex_T___delitem__(vector_complex_T self, SWIGPY_SLICEOBJECT * slice)\n"
 		""},
-	 { "vector_complex_t___getitem__", _wrap_vector_complex_t___getitem__, METH_VARARGS, "\n"
-		"vector_complex_t___getitem__(vector_complex_t self, SWIGPY_SLICEOBJECT * slice) -> vector_complex_t\n"
-		"vector_complex_t___getitem__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i) -> std::vector< std::complex< double > >::value_type const &\n"
+	 { "vector_complex_T___getitem__", _wrap_vector_complex_T___getitem__, METH_VARARGS, "\n"
+		"vector_complex_T___getitem__(vector_complex_T self, SWIGPY_SLICEOBJECT * slice) -> vector_complex_T\n"
+		"vector_complex_T___getitem__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i) -> std::vector< std::complex< double > >::value_type const &\n"
 		""},
-	 { "vector_complex_t___setitem__", _wrap_vector_complex_t___setitem__, METH_VARARGS, "\n"
-		"vector_complex_t___setitem__(vector_complex_t self, SWIGPY_SLICEOBJECT * slice, vector_complex_t v)\n"
-		"vector_complex_t___setitem__(vector_complex_t self, SWIGPY_SLICEOBJECT * slice)\n"
-		"vector_complex_t___setitem__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::value_type const & x)\n"
+	 { "vector_complex_T___setitem__", _wrap_vector_complex_T___setitem__, METH_VARARGS, "\n"
+		"vector_complex_T___setitem__(vector_complex_T self, SWIGPY_SLICEOBJECT * slice, vector_complex_T v)\n"
+		"vector_complex_T___setitem__(vector_complex_T self, SWIGPY_SLICEOBJECT * slice)\n"
+		"vector_complex_T___setitem__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::value_type const & x)\n"
 		""},
-	 { "vector_complex_t_pop", _wrap_vector_complex_t_pop, METH_O, "vector_complex_t_pop(vector_complex_t self) -> std::vector< std::complex< double > >::value_type"},
-	 { "vector_complex_t_append", _wrap_vector_complex_t_append, METH_VARARGS, "vector_complex_t_append(vector_complex_t self, std::vector< std::complex< double > >::value_type const & x)"},
-	 { "vector_complex_t_empty", _wrap_vector_complex_t_empty, METH_O, "vector_complex_t_empty(vector_complex_t self) -> bool"},
-	 { "vector_complex_t_size", _wrap_vector_complex_t_size, METH_O, "vector_complex_t_size(vector_complex_t self) -> std::vector< std::complex< double > >::size_type"},
-	 { "vector_complex_t_swap", _wrap_vector_complex_t_swap, METH_VARARGS, "vector_complex_t_swap(vector_complex_t self, vector_complex_t v)"},
-	 { "vector_complex_t_begin", _wrap_vector_complex_t_begin, METH_O, "vector_complex_t_begin(vector_complex_t self) -> std::vector< std::complex< double > >::iterator"},
-	 { "vector_complex_t_end", _wrap_vector_complex_t_end, METH_O, "vector_complex_t_end(vector_complex_t self) -> std::vector< std::complex< double > >::iterator"},
-	 { "vector_complex_t_rbegin", _wrap_vector_complex_t_rbegin, METH_O, "vector_complex_t_rbegin(vector_complex_t self) -> std::vector< std::complex< double > >::reverse_iterator"},
-	 { "vector_complex_t_rend", _wrap_vector_complex_t_rend, METH_O, "vector_complex_t_rend(vector_complex_t self) -> std::vector< std::complex< double > >::reverse_iterator"},
-	 { "vector_complex_t_clear", _wrap_vector_complex_t_clear, METH_O, "vector_complex_t_clear(vector_complex_t self)"},
-	 { "vector_complex_t_get_allocator", _wrap_vector_complex_t_get_allocator, METH_O, "vector_complex_t_get_allocator(vector_complex_t self) -> std::vector< std::complex< double > >::allocator_type"},
-	 { "vector_complex_t_pop_back", _wrap_vector_complex_t_pop_back, METH_O, "vector_complex_t_pop_back(vector_complex_t self)"},
-	 { "vector_complex_t_erase", _wrap_vector_complex_t_erase, METH_VARARGS, "\n"
-		"vector_complex_t_erase(vector_complex_t self, std::vector< std::complex< double > >::iterator pos) -> std::vector< std::complex< double > >::iterator\n"
-		"vector_complex_t_erase(vector_complex_t self, std::vector< std::complex< double > >::iterator first, std::vector< std::complex< double > >::iterator last) -> std::vector< std::complex< double > >::iterator\n"
+	 { "vector_complex_T_pop", _wrap_vector_complex_T_pop, METH_O, "vector_complex_T_pop(vector_complex_T self) -> std::vector< std::complex< double > >::value_type"},
+	 { "vector_complex_T_append", _wrap_vector_complex_T_append, METH_VARARGS, "vector_complex_T_append(vector_complex_T self, std::vector< std::complex< double > >::value_type const & x)"},
+	 { "vector_complex_T_empty", _wrap_vector_complex_T_empty, METH_O, "vector_complex_T_empty(vector_complex_T self) -> bool"},
+	 { "vector_complex_T_size", _wrap_vector_complex_T_size, METH_O, "vector_complex_T_size(vector_complex_T self) -> std::vector< std::complex< double > >::size_type"},
+	 { "vector_complex_T_swap", _wrap_vector_complex_T_swap, METH_VARARGS, "vector_complex_T_swap(vector_complex_T self, vector_complex_T v)"},
+	 { "vector_complex_T_begin", _wrap_vector_complex_T_begin, METH_O, "vector_complex_T_begin(vector_complex_T self) -> std::vector< std::complex< double > >::iterator"},
+	 { "vector_complex_T_end", _wrap_vector_complex_T_end, METH_O, "vector_complex_T_end(vector_complex_T self) -> std::vector< std::complex< double > >::iterator"},
+	 { "vector_complex_T_rbegin", _wrap_vector_complex_T_rbegin, METH_O, "vector_complex_T_rbegin(vector_complex_T self) -> std::vector< std::complex< double > >::reverse_iterator"},
+	 { "vector_complex_T_rend", _wrap_vector_complex_T_rend, METH_O, "vector_complex_T_rend(vector_complex_T self) -> std::vector< std::complex< double > >::reverse_iterator"},
+	 { "vector_complex_T_clear", _wrap_vector_complex_T_clear, METH_O, "vector_complex_T_clear(vector_complex_T self)"},
+	 { "vector_complex_T_get_allocator", _wrap_vector_complex_T_get_allocator, METH_O, "vector_complex_T_get_allocator(vector_complex_T self) -> std::vector< std::complex< double > >::allocator_type"},
+	 { "vector_complex_T_pop_back", _wrap_vector_complex_T_pop_back, METH_O, "vector_complex_T_pop_back(vector_complex_T self)"},
+	 { "vector_complex_T_erase", _wrap_vector_complex_T_erase, METH_VARARGS, "\n"
+		"vector_complex_T_erase(vector_complex_T self, std::vector< std::complex< double > >::iterator pos) -> std::vector< std::complex< double > >::iterator\n"
+		"vector_complex_T_erase(vector_complex_T self, std::vector< std::complex< double > >::iterator first, std::vector< std::complex< double > >::iterator last) -> std::vector< std::complex< double > >::iterator\n"
 		""},
-	 { "new_vector_complex_t", _wrap_new_vector_complex_t, METH_VARARGS, "\n"
-		"vector_complex_t()\n"
-		"vector_complex_t(vector_complex_t other)\n"
-		"vector_complex_t(std::vector< std::complex< double > >::size_type size)\n"
-		"new_vector_complex_t(std::vector< std::complex< double > >::size_type size, std::vector< std::complex< double > >::value_type const & value) -> vector_complex_t\n"
+	 { "new_vector_complex_T", _wrap_new_vector_complex_T, METH_VARARGS, "\n"
+		"vector_complex_T()\n"
+		"vector_complex_T(vector_complex_T other)\n"
+		"vector_complex_T(std::vector< std::complex< double > >::size_type size)\n"
+		"new_vector_complex_T(std::vector< std::complex< double > >::size_type size, std::vector< std::complex< double > >::value_type const & value) -> vector_complex_T\n"
 		""},
-	 { "vector_complex_t_push_back", _wrap_vector_complex_t_push_back, METH_VARARGS, "vector_complex_t_push_back(vector_complex_t self, std::vector< std::complex< double > >::value_type const & x)"},
-	 { "vector_complex_t_front", _wrap_vector_complex_t_front, METH_O, "vector_complex_t_front(vector_complex_t self) -> std::vector< std::complex< double > >::value_type const &"},
-	 { "vector_complex_t_back", _wrap_vector_complex_t_back, METH_O, "vector_complex_t_back(vector_complex_t self) -> std::vector< std::complex< double > >::value_type const &"},
-	 { "vector_complex_t_assign", _wrap_vector_complex_t_assign, METH_VARARGS, "vector_complex_t_assign(vector_complex_t self, std::vector< std::complex< double > >::size_type n, std::vector< std::complex< double > >::value_type const & x)"},
-	 { "vector_complex_t_resize", _wrap_vector_complex_t_resize, METH_VARARGS, "\n"
-		"vector_complex_t_resize(vector_complex_t self, std::vector< std::complex< double > >::size_type new_size)\n"
-		"vector_complex_t_resize(vector_complex_t self, std::vector< std::complex< double > >::size_type new_size, std::vector< std::complex< double > >::value_type const & x)\n"
+	 { "vector_complex_T_push_back", _wrap_vector_complex_T_push_back, METH_VARARGS, "vector_complex_T_push_back(vector_complex_T self, std::vector< std::complex< double > >::value_type const & x)"},
+	 { "vector_complex_T_front", _wrap_vector_complex_T_front, METH_O, "vector_complex_T_front(vector_complex_T self) -> std::vector< std::complex< double > >::value_type const &"},
+	 { "vector_complex_T_back", _wrap_vector_complex_T_back, METH_O, "vector_complex_T_back(vector_complex_T self) -> std::vector< std::complex< double > >::value_type const &"},
+	 { "vector_complex_T_assign", _wrap_vector_complex_T_assign, METH_VARARGS, "vector_complex_T_assign(vector_complex_T self, std::vector< std::complex< double > >::size_type n, std::vector< std::complex< double > >::value_type const & x)"},
+	 { "vector_complex_T_resize", _wrap_vector_complex_T_resize, METH_VARARGS, "\n"
+		"vector_complex_T_resize(vector_complex_T self, std::vector< std::complex< double > >::size_type new_size)\n"
+		"vector_complex_T_resize(vector_complex_T self, std::vector< std::complex< double > >::size_type new_size, std::vector< std::complex< double > >::value_type const & x)\n"
 		""},
-	 { "vector_complex_t_insert", _wrap_vector_complex_t_insert, METH_VARARGS, "\n"
-		"vector_complex_t_insert(vector_complex_t self, std::vector< std::complex< double > >::iterator pos, std::vector< std::complex< double > >::value_type const & x) -> std::vector< std::complex< double > >::iterator\n"
-		"vector_complex_t_insert(vector_complex_t self, std::vector< std::complex< double > >::iterator pos, std::vector< std::complex< double > >::size_type n, std::vector< std::complex< double > >::value_type const & x)\n"
+	 { "vector_complex_T_insert", _wrap_vector_complex_T_insert, METH_VARARGS, "\n"
+		"vector_complex_T_insert(vector_complex_T self, std::vector< std::complex< double > >::iterator pos, std::vector< std::complex< double > >::value_type const & x) -> std::vector< std::complex< double > >::iterator\n"
+		"vector_complex_T_insert(vector_complex_T self, std::vector< std::complex< double > >::iterator pos, std::vector< std::complex< double > >::size_type n, std::vector< std::complex< double > >::value_type const & x)\n"
 		""},
-	 { "vector_complex_t_reserve", _wrap_vector_complex_t_reserve, METH_VARARGS, "vector_complex_t_reserve(vector_complex_t self, std::vector< std::complex< double > >::size_type n)"},
-	 { "vector_complex_t_capacity", _wrap_vector_complex_t_capacity, METH_O, "vector_complex_t_capacity(vector_complex_t self) -> std::vector< std::complex< double > >::size_type"},
-	 { "delete_vector_complex_t", _wrap_delete_vector_complex_t, METH_O, "delete_vector_complex_t(vector_complex_t self)"},
-	 { "vector_complex_t_swigregister", vector_complex_t_swigregister, METH_O, NULL},
-	 { "vector_complex_t_swiginit", vector_complex_t_swiginit, METH_VARARGS, NULL},
-	 { "vector_string_t_iterator", _wrap_vector_string_t_iterator, METH_O, "vector_string_t_iterator(vector_string_t self) -> SwigPyIterator"},
-	 { "vector_string_t___nonzero__", _wrap_vector_string_t___nonzero__, METH_O, "vector_string_t___nonzero__(vector_string_t self) -> bool"},
-	 { "vector_string_t___bool__", _wrap_vector_string_t___bool__, METH_O, "vector_string_t___bool__(vector_string_t self) -> bool"},
-	 { "vector_string_t___len__", _wrap_vector_string_t___len__, METH_O, "vector_string_t___len__(vector_string_t self) -> std::vector< std::string >::size_type"},
-	 { "vector_string_t___getslice__", _wrap_vector_string_t___getslice__, METH_VARARGS, "vector_string_t___getslice__(vector_string_t self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j) -> vector_string_t"},
-	 { "vector_string_t___setslice__", _wrap_vector_string_t___setslice__, METH_VARARGS, "\n"
-		"vector_string_t___setslice__(vector_string_t self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j)\n"
-		"vector_string_t___setslice__(vector_string_t self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j, vector_string_t v)\n"
+	 { "vector_complex_T_reserve", _wrap_vector_complex_T_reserve, METH_VARARGS, "vector_complex_T_reserve(vector_complex_T self, std::vector< std::complex< double > >::size_type n)"},
+	 { "vector_complex_T_capacity", _wrap_vector_complex_T_capacity, METH_O, "vector_complex_T_capacity(vector_complex_T self) -> std::vector< std::complex< double > >::size_type"},
+	 { "delete_vector_complex_T", _wrap_delete_vector_complex_T, METH_O, "delete_vector_complex_T(vector_complex_T self)"},
+	 { "vector_complex_T_swigregister", vector_complex_T_swigregister, METH_O, NULL},
+	 { "vector_complex_T_swiginit", vector_complex_T_swiginit, METH_VARARGS, NULL},
+	 { "vector_string_T_iterator", _wrap_vector_string_T_iterator, METH_O, "vector_string_T_iterator(vector_string_T self) -> SwigPyIterator"},
+	 { "vector_string_T___nonzero__", _wrap_vector_string_T___nonzero__, METH_O, "vector_string_T___nonzero__(vector_string_T self) -> bool"},
+	 { "vector_string_T___bool__", _wrap_vector_string_T___bool__, METH_O, "vector_string_T___bool__(vector_string_T self) -> bool"},
+	 { "vector_string_T___len__", _wrap_vector_string_T___len__, METH_O, "vector_string_T___len__(vector_string_T self) -> std::vector< std::string >::size_type"},
+	 { "vector_string_T___getslice__", _wrap_vector_string_T___getslice__, METH_VARARGS, "vector_string_T___getslice__(vector_string_T self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j) -> vector_string_T"},
+	 { "vector_string_T___setslice__", _wrap_vector_string_T___setslice__, METH_VARARGS, "\n"
+		"vector_string_T___setslice__(vector_string_T self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j)\n"
+		"vector_string_T___setslice__(vector_string_T self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j, vector_string_T v)\n"
 		""},
-	 { "vector_string_t___delslice__", _wrap_vector_string_t___delslice__, METH_VARARGS, "vector_string_t___delslice__(vector_string_t self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j)"},
-	 { "vector_string_t___delitem__", _wrap_vector_string_t___delitem__, METH_VARARGS, "\n"
-		"vector_string_t___delitem__(vector_string_t self, std::vector< std::string >::difference_type i)\n"
-		"vector_string_t___delitem__(vector_string_t self, SWIGPY_SLICEOBJECT * slice)\n"
+	 { "vector_string_T___delslice__", _wrap_vector_string_T___delslice__, METH_VARARGS, "vector_string_T___delslice__(vector_string_T self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j)"},
+	 { "vector_string_T___delitem__", _wrap_vector_string_T___delitem__, METH_VARARGS, "\n"
+		"vector_string_T___delitem__(vector_string_T self, std::vector< std::string >::difference_type i)\n"
+		"vector_string_T___delitem__(vector_string_T self, SWIGPY_SLICEOBJECT * slice)\n"
 		""},
-	 { "vector_string_t___getitem__", _wrap_vector_string_t___getitem__, METH_VARARGS, "\n"
-		"vector_string_t___getitem__(vector_string_t self, SWIGPY_SLICEOBJECT * slice) -> vector_string_t\n"
-		"vector_string_t___getitem__(vector_string_t self, std::vector< std::string >::difference_type i) -> std::vector< std::string >::value_type const &\n"
+	 { "vector_string_T___getitem__", _wrap_vector_string_T___getitem__, METH_VARARGS, "\n"
+		"vector_string_T___getitem__(vector_string_T self, SWIGPY_SLICEOBJECT * slice) -> vector_string_T\n"
+		"vector_string_T___getitem__(vector_string_T self, std::vector< std::string >::difference_type i) -> std::vector< std::string >::value_type const &\n"
 		""},
-	 { "vector_string_t___setitem__", _wrap_vector_string_t___setitem__, METH_VARARGS, "\n"
-		"vector_string_t___setitem__(vector_string_t self, SWIGPY_SLICEOBJECT * slice, vector_string_t v)\n"
-		"vector_string_t___setitem__(vector_string_t self, SWIGPY_SLICEOBJECT * slice)\n"
-		"vector_string_t___setitem__(vector_string_t self, std::vector< std::string >::difference_type i, std::vector< std::string >::value_type const & x)\n"
+	 { "vector_string_T___setitem__", _wrap_vector_string_T___setitem__, METH_VARARGS, "\n"
+		"vector_string_T___setitem__(vector_string_T self, SWIGPY_SLICEOBJECT * slice, vector_string_T v)\n"
+		"vector_string_T___setitem__(vector_string_T self, SWIGPY_SLICEOBJECT * slice)\n"
+		"vector_string_T___setitem__(vector_string_T self, std::vector< std::string >::difference_type i, std::vector< std::string >::value_type const & x)\n"
 		""},
-	 { "vector_string_t_pop", _wrap_vector_string_t_pop, METH_O, "vector_string_t_pop(vector_string_t self) -> std::vector< std::string >::value_type"},
-	 { "vector_string_t_append", _wrap_vector_string_t_append, METH_VARARGS, "vector_string_t_append(vector_string_t self, std::vector< std::string >::value_type const & x)"},
-	 { "vector_string_t_empty", _wrap_vector_string_t_empty, METH_O, "vector_string_t_empty(vector_string_t self) -> bool"},
-	 { "vector_string_t_size", _wrap_vector_string_t_size, METH_O, "vector_string_t_size(vector_string_t self) -> std::vector< std::string >::size_type"},
-	 { "vector_string_t_swap", _wrap_vector_string_t_swap, METH_VARARGS, "vector_string_t_swap(vector_string_t self, vector_string_t v)"},
-	 { "vector_string_t_begin", _wrap_vector_string_t_begin, METH_O, "vector_string_t_begin(vector_string_t self) -> std::vector< std::string >::iterator"},
-	 { "vector_string_t_end", _wrap_vector_string_t_end, METH_O, "vector_string_t_end(vector_string_t self) -> std::vector< std::string >::iterator"},
-	 { "vector_string_t_rbegin", _wrap_vector_string_t_rbegin, METH_O, "vector_string_t_rbegin(vector_string_t self) -> std::vector< std::string >::reverse_iterator"},
-	 { "vector_string_t_rend", _wrap_vector_string_t_rend, METH_O, "vector_string_t_rend(vector_string_t self) -> std::vector< std::string >::reverse_iterator"},
-	 { "vector_string_t_clear", _wrap_vector_string_t_clear, METH_O, "vector_string_t_clear(vector_string_t self)"},
-	 { "vector_string_t_get_allocator", _wrap_vector_string_t_get_allocator, METH_O, "vector_string_t_get_allocator(vector_string_t self) -> std::vector< std::string >::allocator_type"},
-	 { "vector_string_t_pop_back", _wrap_vector_string_t_pop_back, METH_O, "vector_string_t_pop_back(vector_string_t self)"},
-	 { "vector_string_t_erase", _wrap_vector_string_t_erase, METH_VARARGS, "\n"
-		"vector_string_t_erase(vector_string_t self, std::vector< std::string >::iterator pos) -> std::vector< std::string >::iterator\n"
-		"vector_string_t_erase(vector_string_t self, std::vector< std::string >::iterator first, std::vector< std::string >::iterator last) -> std::vector< std::string >::iterator\n"
+	 { "vector_string_T_pop", _wrap_vector_string_T_pop, METH_O, "vector_string_T_pop(vector_string_T self) -> std::vector< std::string >::value_type"},
+	 { "vector_string_T_append", _wrap_vector_string_T_append, METH_VARARGS, "vector_string_T_append(vector_string_T self, std::vector< std::string >::value_type const & x)"},
+	 { "vector_string_T_empty", _wrap_vector_string_T_empty, METH_O, "vector_string_T_empty(vector_string_T self) -> bool"},
+	 { "vector_string_T_size", _wrap_vector_string_T_size, METH_O, "vector_string_T_size(vector_string_T self) -> std::vector< std::string >::size_type"},
+	 { "vector_string_T_swap", _wrap_vector_string_T_swap, METH_VARARGS, "vector_string_T_swap(vector_string_T self, vector_string_T v)"},
+	 { "vector_string_T_begin", _wrap_vector_string_T_begin, METH_O, "vector_string_T_begin(vector_string_T self) -> std::vector< std::string >::iterator"},
+	 { "vector_string_T_end", _wrap_vector_string_T_end, METH_O, "vector_string_T_end(vector_string_T self) -> std::vector< std::string >::iterator"},
+	 { "vector_string_T_rbegin", _wrap_vector_string_T_rbegin, METH_O, "vector_string_T_rbegin(vector_string_T self) -> std::vector< std::string >::reverse_iterator"},
+	 { "vector_string_T_rend", _wrap_vector_string_T_rend, METH_O, "vector_string_T_rend(vector_string_T self) -> std::vector< std::string >::reverse_iterator"},
+	 { "vector_string_T_clear", _wrap_vector_string_T_clear, METH_O, "vector_string_T_clear(vector_string_T self)"},
+	 { "vector_string_T_get_allocator", _wrap_vector_string_T_get_allocator, METH_O, "vector_string_T_get_allocator(vector_string_T self) -> std::vector< std::string >::allocator_type"},
+	 { "vector_string_T_pop_back", _wrap_vector_string_T_pop_back, METH_O, "vector_string_T_pop_back(vector_string_T self)"},
+	 { "vector_string_T_erase", _wrap_vector_string_T_erase, METH_VARARGS, "\n"
+		"vector_string_T_erase(vector_string_T self, std::vector< std::string >::iterator pos) -> std::vector< std::string >::iterator\n"
+		"vector_string_T_erase(vector_string_T self, std::vector< std::string >::iterator first, std::vector< std::string >::iterator last) -> std::vector< std::string >::iterator\n"
 		""},
-	 { "new_vector_string_t", _wrap_new_vector_string_t, METH_VARARGS, "\n"
-		"vector_string_t()\n"
-		"vector_string_t(vector_string_t other)\n"
-		"vector_string_t(std::vector< std::string >::size_type size)\n"
-		"new_vector_string_t(std::vector< std::string >::size_type size, std::vector< std::string >::value_type const & value) -> vector_string_t\n"
+	 { "new_vector_string_T", _wrap_new_vector_string_T, METH_VARARGS, "\n"
+		"vector_string_T()\n"
+		"vector_string_T(vector_string_T other)\n"
+		"vector_string_T(std::vector< std::string >::size_type size)\n"
+		"new_vector_string_T(std::vector< std::string >::size_type size, std::vector< std::string >::value_type const & value) -> vector_string_T\n"
 		""},
-	 { "vector_string_t_push_back", _wrap_vector_string_t_push_back, METH_VARARGS, "vector_string_t_push_back(vector_string_t self, std::vector< std::string >::value_type const & x)"},
-	 { "vector_string_t_front", _wrap_vector_string_t_front, METH_O, "vector_string_t_front(vector_string_t self) -> std::vector< std::string >::value_type const &"},
-	 { "vector_string_t_back", _wrap_vector_string_t_back, METH_O, "vector_string_t_back(vector_string_t self) -> std::vector< std::string >::value_type const &"},
-	 { "vector_string_t_assign", _wrap_vector_string_t_assign, METH_VARARGS, "vector_string_t_assign(vector_string_t self, std::vector< std::string >::size_type n, std::vector< std::string >::value_type const & x)"},
-	 { "vector_string_t_resize", _wrap_vector_string_t_resize, METH_VARARGS, "\n"
-		"vector_string_t_resize(vector_string_t self, std::vector< std::string >::size_type new_size)\n"
-		"vector_string_t_resize(vector_string_t self, std::vector< std::string >::size_type new_size, std::vector< std::string >::value_type const & x)\n"
+	 { "vector_string_T_push_back", _wrap_vector_string_T_push_back, METH_VARARGS, "vector_string_T_push_back(vector_string_T self, std::vector< std::string >::value_type const & x)"},
+	 { "vector_string_T_front", _wrap_vector_string_T_front, METH_O, "vector_string_T_front(vector_string_T self) -> std::vector< std::string >::value_type const &"},
+	 { "vector_string_T_back", _wrap_vector_string_T_back, METH_O, "vector_string_T_back(vector_string_T self) -> std::vector< std::string >::value_type const &"},
+	 { "vector_string_T_assign", _wrap_vector_string_T_assign, METH_VARARGS, "vector_string_T_assign(vector_string_T self, std::vector< std::string >::size_type n, std::vector< std::string >::value_type const & x)"},
+	 { "vector_string_T_resize", _wrap_vector_string_T_resize, METH_VARARGS, "\n"
+		"vector_string_T_resize(vector_string_T self, std::vector< std::string >::size_type new_size)\n"
+		"vector_string_T_resize(vector_string_T self, std::vector< std::string >::size_type new_size, std::vector< std::string >::value_type const & x)\n"
 		""},
-	 { "vector_string_t_insert", _wrap_vector_string_t_insert, METH_VARARGS, "\n"
-		"vector_string_t_insert(vector_string_t self, std::vector< std::string >::iterator pos, std::vector< std::string >::value_type const & x) -> std::vector< std::string >::iterator\n"
-		"vector_string_t_insert(vector_string_t self, std::vector< std::string >::iterator pos, std::vector< std::string >::size_type n, std::vector< std::string >::value_type const & x)\n"
+	 { "vector_string_T_insert", _wrap_vector_string_T_insert, METH_VARARGS, "\n"
+		"vector_string_T_insert(vector_string_T self, std::vector< std::string >::iterator pos, std::vector< std::string >::value_type const & x) -> std::vector< std::string >::iterator\n"
+		"vector_string_T_insert(vector_string_T self, std::vector< std::string >::iterator pos, std::vector< std::string >::size_type n, std::vector< std::string >::value_type const & x)\n"
 		""},
-	 { "vector_string_t_reserve", _wrap_vector_string_t_reserve, METH_VARARGS, "vector_string_t_reserve(vector_string_t self, std::vector< std::string >::size_type n)"},
-	 { "vector_string_t_capacity", _wrap_vector_string_t_capacity, METH_O, "vector_string_t_capacity(vector_string_t self) -> std::vector< std::string >::size_type"},
-	 { "delete_vector_string_t", _wrap_delete_vector_string_t, METH_O, "delete_vector_string_t(vector_string_t self)"},
-	 { "vector_string_t_swigregister", vector_string_t_swigregister, METH_O, NULL},
-	 { "vector_string_t_swiginit", vector_string_t_swiginit, METH_VARARGS, NULL},
-	 { "map_string_double_t_iterator", _wrap_map_string_double_t_iterator, METH_O, "map_string_double_t_iterator(map_string_double_t self) -> SwigPyIterator"},
-	 { "map_string_double_t___nonzero__", _wrap_map_string_double_t___nonzero__, METH_O, "map_string_double_t___nonzero__(map_string_double_t self) -> bool"},
-	 { "map_string_double_t___bool__", _wrap_map_string_double_t___bool__, METH_O, "map_string_double_t___bool__(map_string_double_t self) -> bool"},
-	 { "map_string_double_t___len__", _wrap_map_string_double_t___len__, METH_O, "map_string_double_t___len__(map_string_double_t self) -> std::map< std::string,double >::size_type"},
-	 { "map_string_double_t___getitem__", _wrap_map_string_double_t___getitem__, METH_VARARGS, "map_string_double_t___getitem__(map_string_double_t self, std::map< std::string,double >::key_type const & key) -> std::map< std::string,double >::mapped_type const &"},
-	 { "map_string_double_t___delitem__", _wrap_map_string_double_t___delitem__, METH_VARARGS, "map_string_double_t___delitem__(map_string_double_t self, std::map< std::string,double >::key_type const & key)"},
-	 { "map_string_double_t_has_key", _wrap_map_string_double_t_has_key, METH_VARARGS, "map_string_double_t_has_key(map_string_double_t self, std::map< std::string,double >::key_type const & key) -> bool"},
-	 { "map_string_double_t_keys", _wrap_map_string_double_t_keys, METH_O, "map_string_double_t_keys(map_string_double_t self) -> PyObject *"},
-	 { "map_string_double_t_values", _wrap_map_string_double_t_values, METH_O, "map_string_double_t_values(map_string_double_t self) -> PyObject *"},
-	 { "map_string_double_t_items", _wrap_map_string_double_t_items, METH_O, "map_string_double_t_items(map_string_double_t self) -> PyObject *"},
-	 { "map_string_double_t___contains__", _wrap_map_string_double_t___contains__, METH_VARARGS, "map_string_double_t___contains__(map_string_double_t self, std::map< std::string,double >::key_type const & key) -> bool"},
-	 { "map_string_double_t_key_iterator", _wrap_map_string_double_t_key_iterator, METH_O, "map_string_double_t_key_iterator(map_string_double_t self) -> SwigPyIterator"},
-	 { "map_string_double_t_value_iterator", _wrap_map_string_double_t_value_iterator, METH_O, "map_string_double_t_value_iterator(map_string_double_t self) -> SwigPyIterator"},
-	 { "map_string_double_t___setitem__", _wrap_map_string_double_t___setitem__, METH_VARARGS, "\n"
-		"map_string_double_t___setitem__(map_string_double_t self, std::map< std::string,double >::key_type const & key)\n"
-		"map_string_double_t___setitem__(map_string_double_t self, std::map< std::string,double >::key_type const & key, std::map< std::string,double >::mapped_type const & x)\n"
+	 { "vector_string_T_reserve", _wrap_vector_string_T_reserve, METH_VARARGS, "vector_string_T_reserve(vector_string_T self, std::vector< std::string >::size_type n)"},
+	 { "vector_string_T_capacity", _wrap_vector_string_T_capacity, METH_O, "vector_string_T_capacity(vector_string_T self) -> std::vector< std::string >::size_type"},
+	 { "delete_vector_string_T", _wrap_delete_vector_string_T, METH_O, "delete_vector_string_T(vector_string_T self)"},
+	 { "vector_string_T_swigregister", vector_string_T_swigregister, METH_O, NULL},
+	 { "vector_string_T_swiginit", vector_string_T_swiginit, METH_VARARGS, NULL},
+	 { "map_string_double_T_iterator", _wrap_map_string_double_T_iterator, METH_O, "map_string_double_T_iterator(map_string_double_T self) -> SwigPyIterator"},
+	 { "map_string_double_T___nonzero__", _wrap_map_string_double_T___nonzero__, METH_O, "map_string_double_T___nonzero__(map_string_double_T self) -> bool"},
+	 { "map_string_double_T___bool__", _wrap_map_string_double_T___bool__, METH_O, "map_string_double_T___bool__(map_string_double_T self) -> bool"},
+	 { "map_string_double_T___len__", _wrap_map_string_double_T___len__, METH_O, "map_string_double_T___len__(map_string_double_T self) -> std::map< std::string,double >::size_type"},
+	 { "map_string_double_T___getitem__", _wrap_map_string_double_T___getitem__, METH_VARARGS, "map_string_double_T___getitem__(map_string_double_T self, std::map< std::string,double >::key_type const & key) -> std::map< std::string,double >::mapped_type const &"},
+	 { "map_string_double_T___delitem__", _wrap_map_string_double_T___delitem__, METH_VARARGS, "map_string_double_T___delitem__(map_string_double_T self, std::map< std::string,double >::key_type const & key)"},
+	 { "map_string_double_T_has_key", _wrap_map_string_double_T_has_key, METH_VARARGS, "map_string_double_T_has_key(map_string_double_T self, std::map< std::string,double >::key_type const & key) -> bool"},
+	 { "map_string_double_T_keys", _wrap_map_string_double_T_keys, METH_O, "map_string_double_T_keys(map_string_double_T self) -> PyObject *"},
+	 { "map_string_double_T_values", _wrap_map_string_double_T_values, METH_O, "map_string_double_T_values(map_string_double_T self) -> PyObject *"},
+	 { "map_string_double_T_items", _wrap_map_string_double_T_items, METH_O, "map_string_double_T_items(map_string_double_T self) -> PyObject *"},
+	 { "map_string_double_T___contains__", _wrap_map_string_double_T___contains__, METH_VARARGS, "map_string_double_T___contains__(map_string_double_T self, std::map< std::string,double >::key_type const & key) -> bool"},
+	 { "map_string_double_T_key_iterator", _wrap_map_string_double_T_key_iterator, METH_O, "map_string_double_T_key_iterator(map_string_double_T self) -> SwigPyIterator"},
+	 { "map_string_double_T_value_iterator", _wrap_map_string_double_T_value_iterator, METH_O, "map_string_double_T_value_iterator(map_string_double_T self) -> SwigPyIterator"},
+	 { "map_string_double_T___setitem__", _wrap_map_string_double_T___setitem__, METH_VARARGS, "\n"
+		"map_string_double_T___setitem__(map_string_double_T self, std::map< std::string,double >::key_type const & key)\n"
+		"map_string_double_T___setitem__(map_string_double_T self, std::map< std::string,double >::key_type const & key, std::map< std::string,double >::mapped_type const & x)\n"
 		""},
-	 { "map_string_double_t_asdict", _wrap_map_string_double_t_asdict, METH_O, "map_string_double_t_asdict(map_string_double_t self) -> PyObject *"},
-	 { "new_map_string_double_t", _wrap_new_map_string_double_t, METH_VARARGS, "\n"
-		"map_string_double_t(std::less< std::string > const & other)\n"
-		"map_string_double_t()\n"
-		"new_map_string_double_t(map_string_double_t other) -> map_string_double_t\n"
+	 { "map_string_double_T_asdict", _wrap_map_string_double_T_asdict, METH_O, "map_string_double_T_asdict(map_string_double_T self) -> PyObject *"},
+	 { "new_map_string_double_T", _wrap_new_map_string_double_T, METH_VARARGS, "\n"
+		"map_string_double_T(std::less< std::string > const & other)\n"
+		"map_string_double_T()\n"
+		"new_map_string_double_T(map_string_double_T other) -> map_string_double_T\n"
 		""},
-	 { "map_string_double_t_empty", _wrap_map_string_double_t_empty, METH_O, "map_string_double_t_empty(map_string_double_t self) -> bool"},
-	 { "map_string_double_t_size", _wrap_map_string_double_t_size, METH_O, "map_string_double_t_size(map_string_double_t self) -> std::map< std::string,double >::size_type"},
-	 { "map_string_double_t_swap", _wrap_map_string_double_t_swap, METH_VARARGS, "map_string_double_t_swap(map_string_double_t self, map_string_double_t v)"},
-	 { "map_string_double_t_begin", _wrap_map_string_double_t_begin, METH_O, "map_string_double_t_begin(map_string_double_t self) -> std::map< std::string,double >::iterator"},
-	 { "map_string_double_t_end", _wrap_map_string_double_t_end, METH_O, "map_string_double_t_end(map_string_double_t self) -> std::map< std::string,double >::iterator"},
-	 { "map_string_double_t_rbegin", _wrap_map_string_double_t_rbegin, METH_O, "map_string_double_t_rbegin(map_string_double_t self) -> std::map< std::string,double >::reverse_iterator"},
-	 { "map_string_double_t_rend", _wrap_map_string_double_t_rend, METH_O, "map_string_double_t_rend(map_string_double_t self) -> std::map< std::string,double >::reverse_iterator"},
-	 { "map_string_double_t_clear", _wrap_map_string_double_t_clear, METH_O, "map_string_double_t_clear(map_string_double_t self)"},
-	 { "map_string_double_t_get_allocator", _wrap_map_string_double_t_get_allocator, METH_O, "map_string_double_t_get_allocator(map_string_double_t self) -> std::map< std::string,double >::allocator_type"},
-	 { "map_string_double_t_count", _wrap_map_string_double_t_count, METH_VARARGS, "map_string_double_t_count(map_string_double_t self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::size_type"},
-	 { "map_string_double_t_erase", _wrap_map_string_double_t_erase, METH_VARARGS, "\n"
-		"map_string_double_t_erase(map_string_double_t self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::size_type\n"
-		"map_string_double_t_erase(map_string_double_t self, std::map< std::string,double >::iterator position)\n"
-		"map_string_double_t_erase(map_string_double_t self, std::map< std::string,double >::iterator first, std::map< std::string,double >::iterator last)\n"
+	 { "map_string_double_T_empty", _wrap_map_string_double_T_empty, METH_O, "map_string_double_T_empty(map_string_double_T self) -> bool"},
+	 { "map_string_double_T_size", _wrap_map_string_double_T_size, METH_O, "map_string_double_T_size(map_string_double_T self) -> std::map< std::string,double >::size_type"},
+	 { "map_string_double_T_swap", _wrap_map_string_double_T_swap, METH_VARARGS, "map_string_double_T_swap(map_string_double_T self, map_string_double_T v)"},
+	 { "map_string_double_T_begin", _wrap_map_string_double_T_begin, METH_O, "map_string_double_T_begin(map_string_double_T self) -> std::map< std::string,double >::iterator"},
+	 { "map_string_double_T_end", _wrap_map_string_double_T_end, METH_O, "map_string_double_T_end(map_string_double_T self) -> std::map< std::string,double >::iterator"},
+	 { "map_string_double_T_rbegin", _wrap_map_string_double_T_rbegin, METH_O, "map_string_double_T_rbegin(map_string_double_T self) -> std::map< std::string,double >::reverse_iterator"},
+	 { "map_string_double_T_rend", _wrap_map_string_double_T_rend, METH_O, "map_string_double_T_rend(map_string_double_T self) -> std::map< std::string,double >::reverse_iterator"},
+	 { "map_string_double_T_clear", _wrap_map_string_double_T_clear, METH_O, "map_string_double_T_clear(map_string_double_T self)"},
+	 { "map_string_double_T_get_allocator", _wrap_map_string_double_T_get_allocator, METH_O, "map_string_double_T_get_allocator(map_string_double_T self) -> std::map< std::string,double >::allocator_type"},
+	 { "map_string_double_T_count", _wrap_map_string_double_T_count, METH_VARARGS, "map_string_double_T_count(map_string_double_T self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::size_type"},
+	 { "map_string_double_T_erase", _wrap_map_string_double_T_erase, METH_VARARGS, "\n"
+		"map_string_double_T_erase(map_string_double_T self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::size_type\n"
+		"map_string_double_T_erase(map_string_double_T self, std::map< std::string,double >::iterator position)\n"
+		"map_string_double_T_erase(map_string_double_T self, std::map< std::string,double >::iterator first, std::map< std::string,double >::iterator last)\n"
 		""},
-	 { "map_string_double_t_find", _wrap_map_string_double_t_find, METH_VARARGS, "map_string_double_t_find(map_string_double_t self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"},
-	 { "map_string_double_t_lower_bound", _wrap_map_string_double_t_lower_bound, METH_VARARGS, "map_string_double_t_lower_bound(map_string_double_t self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"},
-	 { "map_string_double_t_upper_bound", _wrap_map_string_double_t_upper_bound, METH_VARARGS, "map_string_double_t_upper_bound(map_string_double_t self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"},
-	 { "delete_map_string_double_t", _wrap_delete_map_string_double_t, METH_O, "delete_map_string_double_t(map_string_double_t self)"},
-	 { "map_string_double_t_swigregister", map_string_double_t_swigregister, METH_O, NULL},
-	 { "map_string_double_t_swiginit", map_string_double_t_swiginit, METH_VARARGS, NULL},
-	 { "new_pvacuum_double_t", _wrap_new_pvacuum_double_t, METH_VARARGS, "\n"
-		"pvacuum_double_t()\n"
-		"pvacuum_double_t(double first, double second)\n"
-		"new_pvacuum_double_t(pvacuum_double_t other) -> pvacuum_double_t\n"
+	 { "map_string_double_T_find", _wrap_map_string_double_T_find, METH_VARARGS, "map_string_double_T_find(map_string_double_T self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"},
+	 { "map_string_double_T_lower_bound", _wrap_map_string_double_T_lower_bound, METH_VARARGS, "map_string_double_T_lower_bound(map_string_double_T self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"},
+	 { "map_string_double_T_upper_bound", _wrap_map_string_double_T_upper_bound, METH_VARARGS, "map_string_double_T_upper_bound(map_string_double_T self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"},
+	 { "delete_map_string_double_T", _wrap_delete_map_string_double_T, METH_O, "delete_map_string_double_T(map_string_double_T self)"},
+	 { "map_string_double_T_swigregister", map_string_double_T_swigregister, METH_O, NULL},
+	 { "map_string_double_T_swiginit", map_string_double_T_swiginit, METH_VARARGS, NULL},
+	 { "new_pvacuum_double_T", _wrap_new_pvacuum_double_T, METH_VARARGS, "\n"
+		"pvacuum_double_T()\n"
+		"pvacuum_double_T(double first, double second)\n"
+		"new_pvacuum_double_T(pvacuum_double_T other) -> pvacuum_double_T\n"
 		""},
-	 { "pvacuum_double_t_first_set", _wrap_pvacuum_double_t_first_set, METH_VARARGS, "pvacuum_double_t_first_set(pvacuum_double_t self, double first)"},
-	 { "pvacuum_double_t_first_get", _wrap_pvacuum_double_t_first_get, METH_O, "pvacuum_double_t_first_get(pvacuum_double_t self) -> double"},
-	 { "pvacuum_double_t_second_set", _wrap_pvacuum_double_t_second_set, METH_VARARGS, "pvacuum_double_t_second_set(pvacuum_double_t self, double second)"},
-	 { "pvacuum_double_t_second_get", _wrap_pvacuum_double_t_second_get, METH_O, "pvacuum_double_t_second_get(pvacuum_double_t self) -> double"},
-	 { "delete_pvacuum_double_t", _wrap_delete_pvacuum_double_t, METH_O, "delete_pvacuum_double_t(pvacuum_double_t self)"},
-	 { "pvacuum_double_t_swigregister", pvacuum_double_t_swigregister, METH_O, NULL},
-	 { "pvacuum_double_t_swiginit", pvacuum_double_t_swiginit, METH_VARARGS, NULL},
-	 { "vector_pvacuum_double_t_iterator", _wrap_vector_pvacuum_double_t_iterator, METH_O, "vector_pvacuum_double_t_iterator(vector_pvacuum_double_t self) -> SwigPyIterator"},
-	 { "vector_pvacuum_double_t___nonzero__", _wrap_vector_pvacuum_double_t___nonzero__, METH_O, "vector_pvacuum_double_t___nonzero__(vector_pvacuum_double_t self) -> bool"},
-	 { "vector_pvacuum_double_t___bool__", _wrap_vector_pvacuum_double_t___bool__, METH_O, "vector_pvacuum_double_t___bool__(vector_pvacuum_double_t self) -> bool"},
-	 { "vector_pvacuum_double_t___len__", _wrap_vector_pvacuum_double_t___len__, METH_O, "vector_pvacuum_double_t___len__(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::size_type"},
-	 { "vector_pvacuum_double_t___getslice__", _wrap_vector_pvacuum_double_t___getslice__, METH_VARARGS, "vector_pvacuum_double_t___getslice__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j) -> vector_pvacuum_double_t"},
-	 { "vector_pvacuum_double_t___setslice__", _wrap_vector_pvacuum_double_t___setslice__, METH_VARARGS, "\n"
-		"vector_pvacuum_double_t___setslice__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j)\n"
-		"vector_pvacuum_double_t___setslice__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j, vector_pvacuum_double_t v)\n"
+	 { "pvacuum_double_T_first_set", _wrap_pvacuum_double_T_first_set, METH_VARARGS, "pvacuum_double_T_first_set(pvacuum_double_T self, double first)"},
+	 { "pvacuum_double_T_first_get", _wrap_pvacuum_double_T_first_get, METH_O, "pvacuum_double_T_first_get(pvacuum_double_T self) -> double"},
+	 { "pvacuum_double_T_second_set", _wrap_pvacuum_double_T_second_set, METH_VARARGS, "pvacuum_double_T_second_set(pvacuum_double_T self, double second)"},
+	 { "pvacuum_double_T_second_get", _wrap_pvacuum_double_T_second_get, METH_O, "pvacuum_double_T_second_get(pvacuum_double_T self) -> double"},
+	 { "delete_pvacuum_double_T", _wrap_delete_pvacuum_double_T, METH_O, "delete_pvacuum_double_T(pvacuum_double_T self)"},
+	 { "pvacuum_double_T_swigregister", pvacuum_double_T_swigregister, METH_O, NULL},
+	 { "pvacuum_double_T_swiginit", pvacuum_double_T_swiginit, METH_VARARGS, NULL},
+	 { "vector_pvacuum_double_T_iterator", _wrap_vector_pvacuum_double_T_iterator, METH_O, "vector_pvacuum_double_T_iterator(vector_pvacuum_double_T self) -> SwigPyIterator"},
+	 { "vector_pvacuum_double_T___nonzero__", _wrap_vector_pvacuum_double_T___nonzero__, METH_O, "vector_pvacuum_double_T___nonzero__(vector_pvacuum_double_T self) -> bool"},
+	 { "vector_pvacuum_double_T___bool__", _wrap_vector_pvacuum_double_T___bool__, METH_O, "vector_pvacuum_double_T___bool__(vector_pvacuum_double_T self) -> bool"},
+	 { "vector_pvacuum_double_T___len__", _wrap_vector_pvacuum_double_T___len__, METH_O, "vector_pvacuum_double_T___len__(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::size_type"},
+	 { "vector_pvacuum_double_T___getslice__", _wrap_vector_pvacuum_double_T___getslice__, METH_VARARGS, "vector_pvacuum_double_T___getslice__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j) -> vector_pvacuum_double_T"},
+	 { "vector_pvacuum_double_T___setslice__", _wrap_vector_pvacuum_double_T___setslice__, METH_VARARGS, "\n"
+		"vector_pvacuum_double_T___setslice__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j)\n"
+		"vector_pvacuum_double_T___setslice__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j, vector_pvacuum_double_T v)\n"
 		""},
-	 { "vector_pvacuum_double_t___delslice__", _wrap_vector_pvacuum_double_t___delslice__, METH_VARARGS, "vector_pvacuum_double_t___delslice__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j)"},
-	 { "vector_pvacuum_double_t___delitem__", _wrap_vector_pvacuum_double_t___delitem__, METH_VARARGS, "\n"
-		"vector_pvacuum_double_t___delitem__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i)\n"
-		"vector_pvacuum_double_t___delitem__(vector_pvacuum_double_t self, SWIGPY_SLICEOBJECT * slice)\n"
+	 { "vector_pvacuum_double_T___delslice__", _wrap_vector_pvacuum_double_T___delslice__, METH_VARARGS, "vector_pvacuum_double_T___delslice__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j)"},
+	 { "vector_pvacuum_double_T___delitem__", _wrap_vector_pvacuum_double_T___delitem__, METH_VARARGS, "\n"
+		"vector_pvacuum_double_T___delitem__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i)\n"
+		"vector_pvacuum_double_T___delitem__(vector_pvacuum_double_T self, SWIGPY_SLICEOBJECT * slice)\n"
 		""},
-	 { "vector_pvacuum_double_t___getitem__", _wrap_vector_pvacuum_double_t___getitem__, METH_VARARGS, "\n"
-		"vector_pvacuum_double_t___getitem__(vector_pvacuum_double_t self, SWIGPY_SLICEOBJECT * slice) -> vector_pvacuum_double_t\n"
-		"vector_pvacuum_double_t___getitem__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i) -> pvacuum_double_t\n"
+	 { "vector_pvacuum_double_T___getitem__", _wrap_vector_pvacuum_double_T___getitem__, METH_VARARGS, "\n"
+		"vector_pvacuum_double_T___getitem__(vector_pvacuum_double_T self, SWIGPY_SLICEOBJECT * slice) -> vector_pvacuum_double_T\n"
+		"vector_pvacuum_double_T___getitem__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i) -> pvacuum_double_T\n"
 		""},
-	 { "vector_pvacuum_double_t___setitem__", _wrap_vector_pvacuum_double_t___setitem__, METH_VARARGS, "\n"
-		"vector_pvacuum_double_t___setitem__(vector_pvacuum_double_t self, SWIGPY_SLICEOBJECT * slice, vector_pvacuum_double_t v)\n"
-		"vector_pvacuum_double_t___setitem__(vector_pvacuum_double_t self, SWIGPY_SLICEOBJECT * slice)\n"
-		"vector_pvacuum_double_t___setitem__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i, pvacuum_double_t x)\n"
+	 { "vector_pvacuum_double_T___setitem__", _wrap_vector_pvacuum_double_T___setitem__, METH_VARARGS, "\n"
+		"vector_pvacuum_double_T___setitem__(vector_pvacuum_double_T self, SWIGPY_SLICEOBJECT * slice, vector_pvacuum_double_T v)\n"
+		"vector_pvacuum_double_T___setitem__(vector_pvacuum_double_T self, SWIGPY_SLICEOBJECT * slice)\n"
+		"vector_pvacuum_double_T___setitem__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i, pvacuum_double_T x)\n"
 		""},
-	 { "vector_pvacuum_double_t_pop", _wrap_vector_pvacuum_double_t_pop, METH_O, "vector_pvacuum_double_t_pop(vector_pvacuum_double_t self) -> pvacuum_double_t"},
-	 { "vector_pvacuum_double_t_append", _wrap_vector_pvacuum_double_t_append, METH_VARARGS, "vector_pvacuum_double_t_append(vector_pvacuum_double_t self, pvacuum_double_t x)"},
-	 { "vector_pvacuum_double_t_empty", _wrap_vector_pvacuum_double_t_empty, METH_O, "vector_pvacuum_double_t_empty(vector_pvacuum_double_t self) -> bool"},
-	 { "vector_pvacuum_double_t_size", _wrap_vector_pvacuum_double_t_size, METH_O, "vector_pvacuum_double_t_size(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::size_type"},
-	 { "vector_pvacuum_double_t_swap", _wrap_vector_pvacuum_double_t_swap, METH_VARARGS, "vector_pvacuum_double_t_swap(vector_pvacuum_double_t self, vector_pvacuum_double_t v)"},
-	 { "vector_pvacuum_double_t_begin", _wrap_vector_pvacuum_double_t_begin, METH_O, "vector_pvacuum_double_t_begin(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::iterator"},
-	 { "vector_pvacuum_double_t_end", _wrap_vector_pvacuum_double_t_end, METH_O, "vector_pvacuum_double_t_end(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::iterator"},
-	 { "vector_pvacuum_double_t_rbegin", _wrap_vector_pvacuum_double_t_rbegin, METH_O, "vector_pvacuum_double_t_rbegin(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::reverse_iterator"},
-	 { "vector_pvacuum_double_t_rend", _wrap_vector_pvacuum_double_t_rend, METH_O, "vector_pvacuum_double_t_rend(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::reverse_iterator"},
-	 { "vector_pvacuum_double_t_clear", _wrap_vector_pvacuum_double_t_clear, METH_O, "vector_pvacuum_double_t_clear(vector_pvacuum_double_t self)"},
-	 { "vector_pvacuum_double_t_get_allocator", _wrap_vector_pvacuum_double_t_get_allocator, METH_O, "vector_pvacuum_double_t_get_allocator(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::allocator_type"},
-	 { "vector_pvacuum_double_t_pop_back", _wrap_vector_pvacuum_double_t_pop_back, METH_O, "vector_pvacuum_double_t_pop_back(vector_pvacuum_double_t self)"},
-	 { "vector_pvacuum_double_t_erase", _wrap_vector_pvacuum_double_t_erase, METH_VARARGS, "\n"
-		"vector_pvacuum_double_t_erase(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::iterator pos) -> std::vector< std::pair< double,double > >::iterator\n"
-		"vector_pvacuum_double_t_erase(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::iterator first, std::vector< std::pair< double,double > >::iterator last) -> std::vector< std::pair< double,double > >::iterator\n"
+	 { "vector_pvacuum_double_T_pop", _wrap_vector_pvacuum_double_T_pop, METH_O, "vector_pvacuum_double_T_pop(vector_pvacuum_double_T self) -> pvacuum_double_T"},
+	 { "vector_pvacuum_double_T_append", _wrap_vector_pvacuum_double_T_append, METH_VARARGS, "vector_pvacuum_double_T_append(vector_pvacuum_double_T self, pvacuum_double_T x)"},
+	 { "vector_pvacuum_double_T_empty", _wrap_vector_pvacuum_double_T_empty, METH_O, "vector_pvacuum_double_T_empty(vector_pvacuum_double_T self) -> bool"},
+	 { "vector_pvacuum_double_T_size", _wrap_vector_pvacuum_double_T_size, METH_O, "vector_pvacuum_double_T_size(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::size_type"},
+	 { "vector_pvacuum_double_T_swap", _wrap_vector_pvacuum_double_T_swap, METH_VARARGS, "vector_pvacuum_double_T_swap(vector_pvacuum_double_T self, vector_pvacuum_double_T v)"},
+	 { "vector_pvacuum_double_T_begin", _wrap_vector_pvacuum_double_T_begin, METH_O, "vector_pvacuum_double_T_begin(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::iterator"},
+	 { "vector_pvacuum_double_T_end", _wrap_vector_pvacuum_double_T_end, METH_O, "vector_pvacuum_double_T_end(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::iterator"},
+	 { "vector_pvacuum_double_T_rbegin", _wrap_vector_pvacuum_double_T_rbegin, METH_O, "vector_pvacuum_double_T_rbegin(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::reverse_iterator"},
+	 { "vector_pvacuum_double_T_rend", _wrap_vector_pvacuum_double_T_rend, METH_O, "vector_pvacuum_double_T_rend(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::reverse_iterator"},
+	 { "vector_pvacuum_double_T_clear", _wrap_vector_pvacuum_double_T_clear, METH_O, "vector_pvacuum_double_T_clear(vector_pvacuum_double_T self)"},
+	 { "vector_pvacuum_double_T_get_allocator", _wrap_vector_pvacuum_double_T_get_allocator, METH_O, "vector_pvacuum_double_T_get_allocator(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::allocator_type"},
+	 { "vector_pvacuum_double_T_pop_back", _wrap_vector_pvacuum_double_T_pop_back, METH_O, "vector_pvacuum_double_T_pop_back(vector_pvacuum_double_T self)"},
+	 { "vector_pvacuum_double_T_erase", _wrap_vector_pvacuum_double_T_erase, METH_VARARGS, "\n"
+		"vector_pvacuum_double_T_erase(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::iterator pos) -> std::vector< std::pair< double,double > >::iterator\n"
+		"vector_pvacuum_double_T_erase(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::iterator first, std::vector< std::pair< double,double > >::iterator last) -> std::vector< std::pair< double,double > >::iterator\n"
 		""},
-	 { "new_vector_pvacuum_double_t", _wrap_new_vector_pvacuum_double_t, METH_VARARGS, "\n"
-		"vector_pvacuum_double_t()\n"
-		"vector_pvacuum_double_t(vector_pvacuum_double_t other)\n"
-		"vector_pvacuum_double_t(std::vector< std::pair< double,double > >::size_type size)\n"
-		"new_vector_pvacuum_double_t(std::vector< std::pair< double,double > >::size_type size, pvacuum_double_t value) -> vector_pvacuum_double_t\n"
+	 { "new_vector_pvacuum_double_T", _wrap_new_vector_pvacuum_double_T, METH_VARARGS, "\n"
+		"vector_pvacuum_double_T()\n"
+		"vector_pvacuum_double_T(vector_pvacuum_double_T other)\n"
+		"vector_pvacuum_double_T(std::vector< std::pair< double,double > >::size_type size)\n"
+		"new_vector_pvacuum_double_T(std::vector< std::pair< double,double > >::size_type size, pvacuum_double_T value) -> vector_pvacuum_double_T\n"
 		""},
-	 { "vector_pvacuum_double_t_push_back", _wrap_vector_pvacuum_double_t_push_back, METH_VARARGS, "vector_pvacuum_double_t_push_back(vector_pvacuum_double_t self, pvacuum_double_t x)"},
-	 { "vector_pvacuum_double_t_front", _wrap_vector_pvacuum_double_t_front, METH_O, "vector_pvacuum_double_t_front(vector_pvacuum_double_t self) -> pvacuum_double_t"},
-	 { "vector_pvacuum_double_t_back", _wrap_vector_pvacuum_double_t_back, METH_O, "vector_pvacuum_double_t_back(vector_pvacuum_double_t self) -> pvacuum_double_t"},
-	 { "vector_pvacuum_double_t_assign", _wrap_vector_pvacuum_double_t_assign, METH_VARARGS, "vector_pvacuum_double_t_assign(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::size_type n, pvacuum_double_t x)"},
-	 { "vector_pvacuum_double_t_resize", _wrap_vector_pvacuum_double_t_resize, METH_VARARGS, "\n"
-		"vector_pvacuum_double_t_resize(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::size_type new_size)\n"
-		"vector_pvacuum_double_t_resize(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::size_type new_size, pvacuum_double_t x)\n"
+	 { "vector_pvacuum_double_T_push_back", _wrap_vector_pvacuum_double_T_push_back, METH_VARARGS, "vector_pvacuum_double_T_push_back(vector_pvacuum_double_T self, pvacuum_double_T x)"},
+	 { "vector_pvacuum_double_T_front", _wrap_vector_pvacuum_double_T_front, METH_O, "vector_pvacuum_double_T_front(vector_pvacuum_double_T self) -> pvacuum_double_T"},
+	 { "vector_pvacuum_double_T_back", _wrap_vector_pvacuum_double_T_back, METH_O, "vector_pvacuum_double_T_back(vector_pvacuum_double_T self) -> pvacuum_double_T"},
+	 { "vector_pvacuum_double_T_assign", _wrap_vector_pvacuum_double_T_assign, METH_VARARGS, "vector_pvacuum_double_T_assign(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::size_type n, pvacuum_double_T x)"},
+	 { "vector_pvacuum_double_T_resize", _wrap_vector_pvacuum_double_T_resize, METH_VARARGS, "\n"
+		"vector_pvacuum_double_T_resize(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::size_type new_size)\n"
+		"vector_pvacuum_double_T_resize(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::size_type new_size, pvacuum_double_T x)\n"
 		""},
-	 { "vector_pvacuum_double_t_insert", _wrap_vector_pvacuum_double_t_insert, METH_VARARGS, "\n"
-		"vector_pvacuum_double_t_insert(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::iterator pos, pvacuum_double_t x) -> std::vector< std::pair< double,double > >::iterator\n"
-		"vector_pvacuum_double_t_insert(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::iterator pos, std::vector< std::pair< double,double > >::size_type n, pvacuum_double_t x)\n"
+	 { "vector_pvacuum_double_T_insert", _wrap_vector_pvacuum_double_T_insert, METH_VARARGS, "\n"
+		"vector_pvacuum_double_T_insert(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::iterator pos, pvacuum_double_T x) -> std::vector< std::pair< double,double > >::iterator\n"
+		"vector_pvacuum_double_T_insert(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::iterator pos, std::vector< std::pair< double,double > >::size_type n, pvacuum_double_T x)\n"
 		""},
-	 { "vector_pvacuum_double_t_reserve", _wrap_vector_pvacuum_double_t_reserve, METH_VARARGS, "vector_pvacuum_double_t_reserve(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::size_type n)"},
-	 { "vector_pvacuum_double_t_capacity", _wrap_vector_pvacuum_double_t_capacity, METH_O, "vector_pvacuum_double_t_capacity(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::size_type"},
-	 { "delete_vector_pvacuum_double_t", _wrap_delete_vector_pvacuum_double_t, METH_O, "delete_vector_pvacuum_double_t(vector_pvacuum_double_t self)"},
-	 { "vector_pvacuum_double_t_swigregister", vector_pvacuum_double_t_swigregister, METH_O, NULL},
-	 { "vector_pvacuum_double_t_swiginit", vector_pvacuum_double_t_swiginit, METH_VARARGS, NULL},
+	 { "vector_pvacuum_double_T_reserve", _wrap_vector_pvacuum_double_T_reserve, METH_VARARGS, "vector_pvacuum_double_T_reserve(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::size_type n)"},
+	 { "vector_pvacuum_double_T_capacity", _wrap_vector_pvacuum_double_T_capacity, METH_O, "vector_pvacuum_double_T_capacity(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::size_type"},
+	 { "delete_vector_pvacuum_double_T", _wrap_delete_vector_pvacuum_double_T, METH_O, "delete_vector_pvacuum_double_T(vector_pvacuum_double_T self)"},
+	 { "vector_pvacuum_double_T_swigregister", vector_pvacuum_double_T_swigregister, METH_O, NULL},
+	 { "vector_pvacuum_double_T_swiginit", vector_pvacuum_double_T_swiginit, METH_VARARGS, NULL},
 	 { "MesoOptions_use_reciprocal_sum_set", _wrap_MesoOptions_use_reciprocal_sum_set, METH_VARARGS, "MesoOptions_use_reciprocal_sum_set(MesoOptions self, bool use_reciprocal_sum)"},
 	 { "MesoOptions_use_reciprocal_sum_get", _wrap_MesoOptions_use_reciprocal_sum_get, METH_O, "MesoOptions_use_reciprocal_sum_get(MesoOptions self) -> bool"},
 	 { "MesoOptions_radius_factor_set", _wrap_MesoOptions_radius_factor_set, METH_VARARGS, "MesoOptions_radius_factor_set(MesoOptions self, double radius_factor)"},
@@ -30452,10 +30452,10 @@ static PyMethodDef SwigMethods[] = {
 	 { "delete_vector_R3", _wrap_delete_vector_R3, METH_O, "delete_vector_R3(vector_R3 self)"},
 	 { "vector_R3_swigregister", vector_R3_swigregister, METH_O, NULL},
 	 { "vector_R3_swiginit", vector_R3_swiginit, METH_VARARGS, NULL},
-	 { "generateZValues", _wrap_generateZValues, METH_VARARGS, "generateZValues(int n_points, double z_min, double z_max) -> vdouble1d_t"},
-	 { "materialProfileSLD", _wrap_materialProfileSLD, METH_VARARGS, "materialProfileSLD(MultiLayer const & sample, int n_points, double z_min, double z_max) -> vector_complex_t"},
-	 { "magnetizationProfile", _wrap_magnetizationProfile, METH_VARARGS, "magnetizationProfile(MultiLayer const & sample, std::string xyz, int n_points, double z_min, double z_max) -> vdouble1d_t"},
-	 { "defaultMaterialProfileLimits", _wrap_defaultMaterialProfileLimits, METH_O, "defaultMaterialProfileLimits(MultiLayer const & sample) -> pvacuum_double_t"},
+	 { "generateZValues", _wrap_generateZValues, METH_VARARGS, "generateZValues(int n_points, double z_min, double z_max) -> vdouble1d_T"},
+	 { "materialProfileSLD", _wrap_materialProfileSLD, METH_VARARGS, "materialProfileSLD(MultiLayer const & sample, int n_points, double z_min, double z_max) -> vector_complex_T"},
+	 { "magnetizationProfile", _wrap_magnetizationProfile, METH_VARARGS, "magnetizationProfile(MultiLayer const & sample, std::string xyz, int n_points, double z_min, double z_max) -> vdouble1d_T"},
+	 { "defaultMaterialProfileLimits", _wrap_defaultMaterialProfileLimits, METH_O, "defaultMaterialProfileLimits(MultiLayer const & sample) -> pvacuum_double_T"},
 	 { NULL, NULL, 0, NULL }
 };
 
diff --git a/auto/Wrap/libBornAgainSample.py b/auto/Wrap/libBornAgainSample.py
index b6f3298171894d4592637f087497e9fd5bfe007a..bdb6e5206b07fdd066ea27e4080dc7a654479644 100644
--- a/auto/Wrap/libBornAgainSample.py
+++ b/auto/Wrap/libBornAgainSample.py
@@ -153,1191 +153,1191 @@ def deprecated(message):
       return deprecated_func
   return deprecated_decorator
 
-class vdouble1d_t(object):
+class vdouble1d_T(object):
     r"""Proxy of C++ std::vector< double > class."""
 
     thisown = property(lambda x: x.this.own(), lambda x, v: x.this.own(v), doc="The membership flag")
     __repr__ = _swig_repr
 
     def iterator(self):
-        r"""iterator(vdouble1d_t self) -> SwigPyIterator"""
-        return _libBornAgainSample.vdouble1d_t_iterator(self)
+        r"""iterator(vdouble1d_T self) -> SwigPyIterator"""
+        return _libBornAgainSample.vdouble1d_T_iterator(self)
     def __iter__(self):
         return self.iterator()
 
     def __nonzero__(self):
-        r"""__nonzero__(vdouble1d_t self) -> bool"""
-        return _libBornAgainSample.vdouble1d_t___nonzero__(self)
+        r"""__nonzero__(vdouble1d_T self) -> bool"""
+        return _libBornAgainSample.vdouble1d_T___nonzero__(self)
 
     def __bool__(self):
-        r"""__bool__(vdouble1d_t self) -> bool"""
-        return _libBornAgainSample.vdouble1d_t___bool__(self)
+        r"""__bool__(vdouble1d_T self) -> bool"""
+        return _libBornAgainSample.vdouble1d_T___bool__(self)
 
     def __len__(self):
-        r"""__len__(vdouble1d_t self) -> std::vector< double >::size_type"""
-        return _libBornAgainSample.vdouble1d_t___len__(self)
+        r"""__len__(vdouble1d_T self) -> std::vector< double >::size_type"""
+        return _libBornAgainSample.vdouble1d_T___len__(self)
 
     def __getslice__(self, i, j):
-        r"""__getslice__(vdouble1d_t self, std::vector< double >::difference_type i, std::vector< double >::difference_type j) -> vdouble1d_t"""
-        return _libBornAgainSample.vdouble1d_t___getslice__(self, i, j)
+        r"""__getslice__(vdouble1d_T self, std::vector< double >::difference_type i, std::vector< double >::difference_type j) -> vdouble1d_T"""
+        return _libBornAgainSample.vdouble1d_T___getslice__(self, i, j)
 
     def __setslice__(self, *args):
         r"""
-        __setslice__(vdouble1d_t self, std::vector< double >::difference_type i, std::vector< double >::difference_type j)
-        __setslice__(vdouble1d_t self, std::vector< double >::difference_type i, std::vector< double >::difference_type j, vdouble1d_t v)
+        __setslice__(vdouble1d_T self, std::vector< double >::difference_type i, std::vector< double >::difference_type j)
+        __setslice__(vdouble1d_T self, std::vector< double >::difference_type i, std::vector< double >::difference_type j, vdouble1d_T v)
         """
-        return _libBornAgainSample.vdouble1d_t___setslice__(self, *args)
+        return _libBornAgainSample.vdouble1d_T___setslice__(self, *args)
 
     def __delslice__(self, i, j):
-        r"""__delslice__(vdouble1d_t self, std::vector< double >::difference_type i, std::vector< double >::difference_type j)"""
-        return _libBornAgainSample.vdouble1d_t___delslice__(self, i, j)
+        r"""__delslice__(vdouble1d_T self, std::vector< double >::difference_type i, std::vector< double >::difference_type j)"""
+        return _libBornAgainSample.vdouble1d_T___delslice__(self, i, j)
 
     def __delitem__(self, *args):
         r"""
-        __delitem__(vdouble1d_t self, std::vector< double >::difference_type i)
-        __delitem__(vdouble1d_t self, SWIGPY_SLICEOBJECT * slice)
+        __delitem__(vdouble1d_T self, std::vector< double >::difference_type i)
+        __delitem__(vdouble1d_T self, SWIGPY_SLICEOBJECT * slice)
         """
-        return _libBornAgainSample.vdouble1d_t___delitem__(self, *args)
+        return _libBornAgainSample.vdouble1d_T___delitem__(self, *args)
 
     def __getitem__(self, *args):
         r"""
-        __getitem__(vdouble1d_t self, SWIGPY_SLICEOBJECT * slice) -> vdouble1d_t
-        __getitem__(vdouble1d_t self, std::vector< double >::difference_type i) -> std::vector< double >::value_type const &
+        __getitem__(vdouble1d_T self, SWIGPY_SLICEOBJECT * slice) -> vdouble1d_T
+        __getitem__(vdouble1d_T self, std::vector< double >::difference_type i) -> std::vector< double >::value_type const &
         """
-        return _libBornAgainSample.vdouble1d_t___getitem__(self, *args)
+        return _libBornAgainSample.vdouble1d_T___getitem__(self, *args)
 
     def __setitem__(self, *args):
         r"""
-        __setitem__(vdouble1d_t self, SWIGPY_SLICEOBJECT * slice, vdouble1d_t v)
-        __setitem__(vdouble1d_t self, SWIGPY_SLICEOBJECT * slice)
-        __setitem__(vdouble1d_t self, std::vector< double >::difference_type i, std::vector< double >::value_type const & x)
+        __setitem__(vdouble1d_T self, SWIGPY_SLICEOBJECT * slice, vdouble1d_T v)
+        __setitem__(vdouble1d_T self, SWIGPY_SLICEOBJECT * slice)
+        __setitem__(vdouble1d_T self, std::vector< double >::difference_type i, std::vector< double >::value_type const & x)
         """
-        return _libBornAgainSample.vdouble1d_t___setitem__(self, *args)
+        return _libBornAgainSample.vdouble1d_T___setitem__(self, *args)
 
     def pop(self):
-        r"""pop(vdouble1d_t self) -> std::vector< double >::value_type"""
-        return _libBornAgainSample.vdouble1d_t_pop(self)
+        r"""pop(vdouble1d_T self) -> std::vector< double >::value_type"""
+        return _libBornAgainSample.vdouble1d_T_pop(self)
 
     def append(self, x):
-        r"""append(vdouble1d_t self, std::vector< double >::value_type const & x)"""
-        return _libBornAgainSample.vdouble1d_t_append(self, x)
+        r"""append(vdouble1d_T self, std::vector< double >::value_type const & x)"""
+        return _libBornAgainSample.vdouble1d_T_append(self, x)
 
     def empty(self):
-        r"""empty(vdouble1d_t self) -> bool"""
-        return _libBornAgainSample.vdouble1d_t_empty(self)
+        r"""empty(vdouble1d_T self) -> bool"""
+        return _libBornAgainSample.vdouble1d_T_empty(self)
 
     def size(self):
-        r"""size(vdouble1d_t self) -> std::vector< double >::size_type"""
-        return _libBornAgainSample.vdouble1d_t_size(self)
+        r"""size(vdouble1d_T self) -> std::vector< double >::size_type"""
+        return _libBornAgainSample.vdouble1d_T_size(self)
 
     def swap(self, v):
-        r"""swap(vdouble1d_t self, vdouble1d_t v)"""
-        return _libBornAgainSample.vdouble1d_t_swap(self, v)
+        r"""swap(vdouble1d_T self, vdouble1d_T v)"""
+        return _libBornAgainSample.vdouble1d_T_swap(self, v)
 
     def begin(self):
-        r"""begin(vdouble1d_t self) -> std::vector< double >::iterator"""
-        return _libBornAgainSample.vdouble1d_t_begin(self)
+        r"""begin(vdouble1d_T self) -> std::vector< double >::iterator"""
+        return _libBornAgainSample.vdouble1d_T_begin(self)
 
     def end(self):
-        r"""end(vdouble1d_t self) -> std::vector< double >::iterator"""
-        return _libBornAgainSample.vdouble1d_t_end(self)
+        r"""end(vdouble1d_T self) -> std::vector< double >::iterator"""
+        return _libBornAgainSample.vdouble1d_T_end(self)
 
     def rbegin(self):
-        r"""rbegin(vdouble1d_t self) -> std::vector< double >::reverse_iterator"""
-        return _libBornAgainSample.vdouble1d_t_rbegin(self)
+        r"""rbegin(vdouble1d_T self) -> std::vector< double >::reverse_iterator"""
+        return _libBornAgainSample.vdouble1d_T_rbegin(self)
 
     def rend(self):
-        r"""rend(vdouble1d_t self) -> std::vector< double >::reverse_iterator"""
-        return _libBornAgainSample.vdouble1d_t_rend(self)
+        r"""rend(vdouble1d_T self) -> std::vector< double >::reverse_iterator"""
+        return _libBornAgainSample.vdouble1d_T_rend(self)
 
     def clear(self):
-        r"""clear(vdouble1d_t self)"""
-        return _libBornAgainSample.vdouble1d_t_clear(self)
+        r"""clear(vdouble1d_T self)"""
+        return _libBornAgainSample.vdouble1d_T_clear(self)
 
     def get_allocator(self):
-        r"""get_allocator(vdouble1d_t self) -> std::vector< double >::allocator_type"""
-        return _libBornAgainSample.vdouble1d_t_get_allocator(self)
+        r"""get_allocator(vdouble1d_T self) -> std::vector< double >::allocator_type"""
+        return _libBornAgainSample.vdouble1d_T_get_allocator(self)
 
     def pop_back(self):
-        r"""pop_back(vdouble1d_t self)"""
-        return _libBornAgainSample.vdouble1d_t_pop_back(self)
+        r"""pop_back(vdouble1d_T self)"""
+        return _libBornAgainSample.vdouble1d_T_pop_back(self)
 
     def erase(self, *args):
         r"""
-        erase(vdouble1d_t self, std::vector< double >::iterator pos) -> std::vector< double >::iterator
-        erase(vdouble1d_t self, std::vector< double >::iterator first, std::vector< double >::iterator last) -> std::vector< double >::iterator
+        erase(vdouble1d_T self, std::vector< double >::iterator pos) -> std::vector< double >::iterator
+        erase(vdouble1d_T self, std::vector< double >::iterator first, std::vector< double >::iterator last) -> std::vector< double >::iterator
         """
-        return _libBornAgainSample.vdouble1d_t_erase(self, *args)
+        return _libBornAgainSample.vdouble1d_T_erase(self, *args)
 
     def __init__(self, *args):
         r"""
-        __init__(vdouble1d_t self) -> vdouble1d_t
-        __init__(vdouble1d_t self, vdouble1d_t other) -> vdouble1d_t
-        __init__(vdouble1d_t self, std::vector< double >::size_type size) -> vdouble1d_t
-        __init__(vdouble1d_t self, std::vector< double >::size_type size, std::vector< double >::value_type const & value) -> vdouble1d_t
+        __init__(vdouble1d_T self) -> vdouble1d_T
+        __init__(vdouble1d_T self, vdouble1d_T other) -> vdouble1d_T
+        __init__(vdouble1d_T self, std::vector< double >::size_type size) -> vdouble1d_T
+        __init__(vdouble1d_T self, std::vector< double >::size_type size, std::vector< double >::value_type const & value) -> vdouble1d_T
         """
-        _libBornAgainSample.vdouble1d_t_swiginit(self, _libBornAgainSample.new_vdouble1d_t(*args))
+        _libBornAgainSample.vdouble1d_T_swiginit(self, _libBornAgainSample.new_vdouble1d_T(*args))
 
     def push_back(self, x):
-        r"""push_back(vdouble1d_t self, std::vector< double >::value_type const & x)"""
-        return _libBornAgainSample.vdouble1d_t_push_back(self, x)
+        r"""push_back(vdouble1d_T self, std::vector< double >::value_type const & x)"""
+        return _libBornAgainSample.vdouble1d_T_push_back(self, x)
 
     def front(self):
-        r"""front(vdouble1d_t self) -> std::vector< double >::value_type const &"""
-        return _libBornAgainSample.vdouble1d_t_front(self)
+        r"""front(vdouble1d_T self) -> std::vector< double >::value_type const &"""
+        return _libBornAgainSample.vdouble1d_T_front(self)
 
     def back(self):
-        r"""back(vdouble1d_t self) -> std::vector< double >::value_type const &"""
-        return _libBornAgainSample.vdouble1d_t_back(self)
+        r"""back(vdouble1d_T self) -> std::vector< double >::value_type const &"""
+        return _libBornAgainSample.vdouble1d_T_back(self)
 
     def assign(self, n, x):
-        r"""assign(vdouble1d_t self, std::vector< double >::size_type n, std::vector< double >::value_type const & x)"""
-        return _libBornAgainSample.vdouble1d_t_assign(self, n, x)
+        r"""assign(vdouble1d_T self, std::vector< double >::size_type n, std::vector< double >::value_type const & x)"""
+        return _libBornAgainSample.vdouble1d_T_assign(self, n, x)
 
     def resize(self, *args):
         r"""
-        resize(vdouble1d_t self, std::vector< double >::size_type new_size)
-        resize(vdouble1d_t self, std::vector< double >::size_type new_size, std::vector< double >::value_type const & x)
+        resize(vdouble1d_T self, std::vector< double >::size_type new_size)
+        resize(vdouble1d_T self, std::vector< double >::size_type new_size, std::vector< double >::value_type const & x)
         """
-        return _libBornAgainSample.vdouble1d_t_resize(self, *args)
+        return _libBornAgainSample.vdouble1d_T_resize(self, *args)
 
     def insert(self, *args):
         r"""
-        insert(vdouble1d_t self, std::vector< double >::iterator pos, std::vector< double >::value_type const & x) -> std::vector< double >::iterator
-        insert(vdouble1d_t self, std::vector< double >::iterator pos, std::vector< double >::size_type n, std::vector< double >::value_type const & x)
+        insert(vdouble1d_T self, std::vector< double >::iterator pos, std::vector< double >::value_type const & x) -> std::vector< double >::iterator
+        insert(vdouble1d_T self, std::vector< double >::iterator pos, std::vector< double >::size_type n, std::vector< double >::value_type const & x)
         """
-        return _libBornAgainSample.vdouble1d_t_insert(self, *args)
+        return _libBornAgainSample.vdouble1d_T_insert(self, *args)
 
     def reserve(self, n):
-        r"""reserve(vdouble1d_t self, std::vector< double >::size_type n)"""
-        return _libBornAgainSample.vdouble1d_t_reserve(self, n)
+        r"""reserve(vdouble1d_T self, std::vector< double >::size_type n)"""
+        return _libBornAgainSample.vdouble1d_T_reserve(self, n)
 
     def capacity(self):
-        r"""capacity(vdouble1d_t self) -> std::vector< double >::size_type"""
-        return _libBornAgainSample.vdouble1d_t_capacity(self)
-    __swig_destroy__ = _libBornAgainSample.delete_vdouble1d_t
+        r"""capacity(vdouble1d_T self) -> std::vector< double >::size_type"""
+        return _libBornAgainSample.vdouble1d_T_capacity(self)
+    __swig_destroy__ = _libBornAgainSample.delete_vdouble1d_T
 
-# Register vdouble1d_t in _libBornAgainSample:
-_libBornAgainSample.vdouble1d_t_swigregister(vdouble1d_t)
-class vdouble2d_t(object):
+# Register vdouble1d_T in _libBornAgainSample:
+_libBornAgainSample.vdouble1d_T_swigregister(vdouble1d_T)
+class vdouble2d_T(object):
     r"""Proxy of C++ std::vector< std::vector< double > > class."""
 
     thisown = property(lambda x: x.this.own(), lambda x, v: x.this.own(v), doc="The membership flag")
     __repr__ = _swig_repr
 
     def iterator(self):
-        r"""iterator(vdouble2d_t self) -> SwigPyIterator"""
-        return _libBornAgainSample.vdouble2d_t_iterator(self)
+        r"""iterator(vdouble2d_T self) -> SwigPyIterator"""
+        return _libBornAgainSample.vdouble2d_T_iterator(self)
     def __iter__(self):
         return self.iterator()
 
     def __nonzero__(self):
-        r"""__nonzero__(vdouble2d_t self) -> bool"""
-        return _libBornAgainSample.vdouble2d_t___nonzero__(self)
+        r"""__nonzero__(vdouble2d_T self) -> bool"""
+        return _libBornAgainSample.vdouble2d_T___nonzero__(self)
 
     def __bool__(self):
-        r"""__bool__(vdouble2d_t self) -> bool"""
-        return _libBornAgainSample.vdouble2d_t___bool__(self)
+        r"""__bool__(vdouble2d_T self) -> bool"""
+        return _libBornAgainSample.vdouble2d_T___bool__(self)
 
     def __len__(self):
-        r"""__len__(vdouble2d_t self) -> std::vector< std::vector< double > >::size_type"""
-        return _libBornAgainSample.vdouble2d_t___len__(self)
+        r"""__len__(vdouble2d_T self) -> std::vector< std::vector< double > >::size_type"""
+        return _libBornAgainSample.vdouble2d_T___len__(self)
 
     def __getslice__(self, i, j):
-        r"""__getslice__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j) -> vdouble2d_t"""
-        return _libBornAgainSample.vdouble2d_t___getslice__(self, i, j)
+        r"""__getslice__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j) -> vdouble2d_T"""
+        return _libBornAgainSample.vdouble2d_T___getslice__(self, i, j)
 
     def __setslice__(self, *args):
         r"""
-        __setslice__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j)
-        __setslice__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j, vdouble2d_t v)
+        __setslice__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j)
+        __setslice__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j, vdouble2d_T v)
         """
-        return _libBornAgainSample.vdouble2d_t___setslice__(self, *args)
+        return _libBornAgainSample.vdouble2d_T___setslice__(self, *args)
 
     def __delslice__(self, i, j):
-        r"""__delslice__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j)"""
-        return _libBornAgainSample.vdouble2d_t___delslice__(self, i, j)
+        r"""__delslice__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j)"""
+        return _libBornAgainSample.vdouble2d_T___delslice__(self, i, j)
 
     def __delitem__(self, *args):
         r"""
-        __delitem__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i)
-        __delitem__(vdouble2d_t self, SWIGPY_SLICEOBJECT * slice)
+        __delitem__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i)
+        __delitem__(vdouble2d_T self, SWIGPY_SLICEOBJECT * slice)
         """
-        return _libBornAgainSample.vdouble2d_t___delitem__(self, *args)
+        return _libBornAgainSample.vdouble2d_T___delitem__(self, *args)
 
     def __getitem__(self, *args):
         r"""
-        __getitem__(vdouble2d_t self, SWIGPY_SLICEOBJECT * slice) -> vdouble2d_t
-        __getitem__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i) -> vdouble1d_t
+        __getitem__(vdouble2d_T self, SWIGPY_SLICEOBJECT * slice) -> vdouble2d_T
+        __getitem__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i) -> vdouble1d_T
         """
-        return _libBornAgainSample.vdouble2d_t___getitem__(self, *args)
+        return _libBornAgainSample.vdouble2d_T___getitem__(self, *args)
 
     def __setitem__(self, *args):
         r"""
-        __setitem__(vdouble2d_t self, SWIGPY_SLICEOBJECT * slice, vdouble2d_t v)
-        __setitem__(vdouble2d_t self, SWIGPY_SLICEOBJECT * slice)
-        __setitem__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i, vdouble1d_t x)
+        __setitem__(vdouble2d_T self, SWIGPY_SLICEOBJECT * slice, vdouble2d_T v)
+        __setitem__(vdouble2d_T self, SWIGPY_SLICEOBJECT * slice)
+        __setitem__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i, vdouble1d_T x)
         """
-        return _libBornAgainSample.vdouble2d_t___setitem__(self, *args)
+        return _libBornAgainSample.vdouble2d_T___setitem__(self, *args)
 
     def pop(self):
-        r"""pop(vdouble2d_t self) -> vdouble1d_t"""
-        return _libBornAgainSample.vdouble2d_t_pop(self)
+        r"""pop(vdouble2d_T self) -> vdouble1d_T"""
+        return _libBornAgainSample.vdouble2d_T_pop(self)
 
     def append(self, x):
-        r"""append(vdouble2d_t self, vdouble1d_t x)"""
-        return _libBornAgainSample.vdouble2d_t_append(self, x)
+        r"""append(vdouble2d_T self, vdouble1d_T x)"""
+        return _libBornAgainSample.vdouble2d_T_append(self, x)
 
     def empty(self):
-        r"""empty(vdouble2d_t self) -> bool"""
-        return _libBornAgainSample.vdouble2d_t_empty(self)
+        r"""empty(vdouble2d_T self) -> bool"""
+        return _libBornAgainSample.vdouble2d_T_empty(self)
 
     def size(self):
-        r"""size(vdouble2d_t self) -> std::vector< std::vector< double > >::size_type"""
-        return _libBornAgainSample.vdouble2d_t_size(self)
+        r"""size(vdouble2d_T self) -> std::vector< std::vector< double > >::size_type"""
+        return _libBornAgainSample.vdouble2d_T_size(self)
 
     def swap(self, v):
-        r"""swap(vdouble2d_t self, vdouble2d_t v)"""
-        return _libBornAgainSample.vdouble2d_t_swap(self, v)
+        r"""swap(vdouble2d_T self, vdouble2d_T v)"""
+        return _libBornAgainSample.vdouble2d_T_swap(self, v)
 
     def begin(self):
-        r"""begin(vdouble2d_t self) -> std::vector< std::vector< double > >::iterator"""
-        return _libBornAgainSample.vdouble2d_t_begin(self)
+        r"""begin(vdouble2d_T self) -> std::vector< std::vector< double > >::iterator"""
+        return _libBornAgainSample.vdouble2d_T_begin(self)
 
     def end(self):
-        r"""end(vdouble2d_t self) -> std::vector< std::vector< double > >::iterator"""
-        return _libBornAgainSample.vdouble2d_t_end(self)
+        r"""end(vdouble2d_T self) -> std::vector< std::vector< double > >::iterator"""
+        return _libBornAgainSample.vdouble2d_T_end(self)
 
     def rbegin(self):
-        r"""rbegin(vdouble2d_t self) -> std::vector< std::vector< double > >::reverse_iterator"""
-        return _libBornAgainSample.vdouble2d_t_rbegin(self)
+        r"""rbegin(vdouble2d_T self) -> std::vector< std::vector< double > >::reverse_iterator"""
+        return _libBornAgainSample.vdouble2d_T_rbegin(self)
 
     def rend(self):
-        r"""rend(vdouble2d_t self) -> std::vector< std::vector< double > >::reverse_iterator"""
-        return _libBornAgainSample.vdouble2d_t_rend(self)
+        r"""rend(vdouble2d_T self) -> std::vector< std::vector< double > >::reverse_iterator"""
+        return _libBornAgainSample.vdouble2d_T_rend(self)
 
     def clear(self):
-        r"""clear(vdouble2d_t self)"""
-        return _libBornAgainSample.vdouble2d_t_clear(self)
+        r"""clear(vdouble2d_T self)"""
+        return _libBornAgainSample.vdouble2d_T_clear(self)
 
     def get_allocator(self):
-        r"""get_allocator(vdouble2d_t self) -> std::vector< std::vector< double > >::allocator_type"""
-        return _libBornAgainSample.vdouble2d_t_get_allocator(self)
+        r"""get_allocator(vdouble2d_T self) -> std::vector< std::vector< double > >::allocator_type"""
+        return _libBornAgainSample.vdouble2d_T_get_allocator(self)
 
     def pop_back(self):
-        r"""pop_back(vdouble2d_t self)"""
-        return _libBornAgainSample.vdouble2d_t_pop_back(self)
+        r"""pop_back(vdouble2d_T self)"""
+        return _libBornAgainSample.vdouble2d_T_pop_back(self)
 
     def erase(self, *args):
         r"""
-        erase(vdouble2d_t self, std::vector< std::vector< double > >::iterator pos) -> std::vector< std::vector< double > >::iterator
-        erase(vdouble2d_t self, std::vector< std::vector< double > >::iterator first, std::vector< std::vector< double > >::iterator last) -> std::vector< std::vector< double > >::iterator
+        erase(vdouble2d_T self, std::vector< std::vector< double > >::iterator pos) -> std::vector< std::vector< double > >::iterator
+        erase(vdouble2d_T self, std::vector< std::vector< double > >::iterator first, std::vector< std::vector< double > >::iterator last) -> std::vector< std::vector< double > >::iterator
         """
-        return _libBornAgainSample.vdouble2d_t_erase(self, *args)
+        return _libBornAgainSample.vdouble2d_T_erase(self, *args)
 
     def __init__(self, *args):
         r"""
-        __init__(vdouble2d_t self) -> vdouble2d_t
-        __init__(vdouble2d_t self, vdouble2d_t other) -> vdouble2d_t
-        __init__(vdouble2d_t self, std::vector< std::vector< double > >::size_type size) -> vdouble2d_t
-        __init__(vdouble2d_t self, std::vector< std::vector< double > >::size_type size, vdouble1d_t value) -> vdouble2d_t
+        __init__(vdouble2d_T self) -> vdouble2d_T
+        __init__(vdouble2d_T self, vdouble2d_T other) -> vdouble2d_T
+        __init__(vdouble2d_T self, std::vector< std::vector< double > >::size_type size) -> vdouble2d_T
+        __init__(vdouble2d_T self, std::vector< std::vector< double > >::size_type size, vdouble1d_T value) -> vdouble2d_T
         """
-        _libBornAgainSample.vdouble2d_t_swiginit(self, _libBornAgainSample.new_vdouble2d_t(*args))
+        _libBornAgainSample.vdouble2d_T_swiginit(self, _libBornAgainSample.new_vdouble2d_T(*args))
 
     def push_back(self, x):
-        r"""push_back(vdouble2d_t self, vdouble1d_t x)"""
-        return _libBornAgainSample.vdouble2d_t_push_back(self, x)
+        r"""push_back(vdouble2d_T self, vdouble1d_T x)"""
+        return _libBornAgainSample.vdouble2d_T_push_back(self, x)
 
     def front(self):
-        r"""front(vdouble2d_t self) -> vdouble1d_t"""
-        return _libBornAgainSample.vdouble2d_t_front(self)
+        r"""front(vdouble2d_T self) -> vdouble1d_T"""
+        return _libBornAgainSample.vdouble2d_T_front(self)
 
     def back(self):
-        r"""back(vdouble2d_t self) -> vdouble1d_t"""
-        return _libBornAgainSample.vdouble2d_t_back(self)
+        r"""back(vdouble2d_T self) -> vdouble1d_T"""
+        return _libBornAgainSample.vdouble2d_T_back(self)
 
     def assign(self, n, x):
-        r"""assign(vdouble2d_t self, std::vector< std::vector< double > >::size_type n, vdouble1d_t x)"""
-        return _libBornAgainSample.vdouble2d_t_assign(self, n, x)
+        r"""assign(vdouble2d_T self, std::vector< std::vector< double > >::size_type n, vdouble1d_T x)"""
+        return _libBornAgainSample.vdouble2d_T_assign(self, n, x)
 
     def resize(self, *args):
         r"""
-        resize(vdouble2d_t self, std::vector< std::vector< double > >::size_type new_size)
-        resize(vdouble2d_t self, std::vector< std::vector< double > >::size_type new_size, vdouble1d_t x)
+        resize(vdouble2d_T self, std::vector< std::vector< double > >::size_type new_size)
+        resize(vdouble2d_T self, std::vector< std::vector< double > >::size_type new_size, vdouble1d_T x)
         """
-        return _libBornAgainSample.vdouble2d_t_resize(self, *args)
+        return _libBornAgainSample.vdouble2d_T_resize(self, *args)
 
     def insert(self, *args):
         r"""
-        insert(vdouble2d_t self, std::vector< std::vector< double > >::iterator pos, vdouble1d_t x) -> std::vector< std::vector< double > >::iterator
-        insert(vdouble2d_t self, std::vector< std::vector< double > >::iterator pos, std::vector< std::vector< double > >::size_type n, vdouble1d_t x)
+        insert(vdouble2d_T self, std::vector< std::vector< double > >::iterator pos, vdouble1d_T x) -> std::vector< std::vector< double > >::iterator
+        insert(vdouble2d_T self, std::vector< std::vector< double > >::iterator pos, std::vector< std::vector< double > >::size_type n, vdouble1d_T x)
         """
-        return _libBornAgainSample.vdouble2d_t_insert(self, *args)
+        return _libBornAgainSample.vdouble2d_T_insert(self, *args)
 
     def reserve(self, n):
-        r"""reserve(vdouble2d_t self, std::vector< std::vector< double > >::size_type n)"""
-        return _libBornAgainSample.vdouble2d_t_reserve(self, n)
+        r"""reserve(vdouble2d_T self, std::vector< std::vector< double > >::size_type n)"""
+        return _libBornAgainSample.vdouble2d_T_reserve(self, n)
 
     def capacity(self):
-        r"""capacity(vdouble2d_t self) -> std::vector< std::vector< double > >::size_type"""
-        return _libBornAgainSample.vdouble2d_t_capacity(self)
-    __swig_destroy__ = _libBornAgainSample.delete_vdouble2d_t
+        r"""capacity(vdouble2d_T self) -> std::vector< std::vector< double > >::size_type"""
+        return _libBornAgainSample.vdouble2d_T_capacity(self)
+    __swig_destroy__ = _libBornAgainSample.delete_vdouble2d_T
 
-# Register vdouble2d_t in _libBornAgainSample:
-_libBornAgainSample.vdouble2d_t_swigregister(vdouble2d_t)
-class vector_integer_t(object):
+# Register vdouble2d_T in _libBornAgainSample:
+_libBornAgainSample.vdouble2d_T_swigregister(vdouble2d_T)
+class vector_integer_T(object):
     r"""Proxy of C++ std::vector< int > class."""
 
     thisown = property(lambda x: x.this.own(), lambda x, v: x.this.own(v), doc="The membership flag")
     __repr__ = _swig_repr
 
     def iterator(self):
-        r"""iterator(vector_integer_t self) -> SwigPyIterator"""
-        return _libBornAgainSample.vector_integer_t_iterator(self)
+        r"""iterator(vector_integer_T self) -> SwigPyIterator"""
+        return _libBornAgainSample.vector_integer_T_iterator(self)
     def __iter__(self):
         return self.iterator()
 
     def __nonzero__(self):
-        r"""__nonzero__(vector_integer_t self) -> bool"""
-        return _libBornAgainSample.vector_integer_t___nonzero__(self)
+        r"""__nonzero__(vector_integer_T self) -> bool"""
+        return _libBornAgainSample.vector_integer_T___nonzero__(self)
 
     def __bool__(self):
-        r"""__bool__(vector_integer_t self) -> bool"""
-        return _libBornAgainSample.vector_integer_t___bool__(self)
+        r"""__bool__(vector_integer_T self) -> bool"""
+        return _libBornAgainSample.vector_integer_T___bool__(self)
 
     def __len__(self):
-        r"""__len__(vector_integer_t self) -> std::vector< int >::size_type"""
-        return _libBornAgainSample.vector_integer_t___len__(self)
+        r"""__len__(vector_integer_T self) -> std::vector< int >::size_type"""
+        return _libBornAgainSample.vector_integer_T___len__(self)
 
     def __getslice__(self, i, j):
-        r"""__getslice__(vector_integer_t self, std::vector< int >::difference_type i, std::vector< int >::difference_type j) -> vector_integer_t"""
-        return _libBornAgainSample.vector_integer_t___getslice__(self, i, j)
+        r"""__getslice__(vector_integer_T self, std::vector< int >::difference_type i, std::vector< int >::difference_type j) -> vector_integer_T"""
+        return _libBornAgainSample.vector_integer_T___getslice__(self, i, j)
 
     def __setslice__(self, *args):
         r"""
-        __setslice__(vector_integer_t self, std::vector< int >::difference_type i, std::vector< int >::difference_type j)
-        __setslice__(vector_integer_t self, std::vector< int >::difference_type i, std::vector< int >::difference_type j, vector_integer_t v)
+        __setslice__(vector_integer_T self, std::vector< int >::difference_type i, std::vector< int >::difference_type j)
+        __setslice__(vector_integer_T self, std::vector< int >::difference_type i, std::vector< int >::difference_type j, vector_integer_T v)
         """
-        return _libBornAgainSample.vector_integer_t___setslice__(self, *args)
+        return _libBornAgainSample.vector_integer_T___setslice__(self, *args)
 
     def __delslice__(self, i, j):
-        r"""__delslice__(vector_integer_t self, std::vector< int >::difference_type i, std::vector< int >::difference_type j)"""
-        return _libBornAgainSample.vector_integer_t___delslice__(self, i, j)
+        r"""__delslice__(vector_integer_T self, std::vector< int >::difference_type i, std::vector< int >::difference_type j)"""
+        return _libBornAgainSample.vector_integer_T___delslice__(self, i, j)
 
     def __delitem__(self, *args):
         r"""
-        __delitem__(vector_integer_t self, std::vector< int >::difference_type i)
-        __delitem__(vector_integer_t self, SWIGPY_SLICEOBJECT * slice)
+        __delitem__(vector_integer_T self, std::vector< int >::difference_type i)
+        __delitem__(vector_integer_T self, SWIGPY_SLICEOBJECT * slice)
         """
-        return _libBornAgainSample.vector_integer_t___delitem__(self, *args)
+        return _libBornAgainSample.vector_integer_T___delitem__(self, *args)
 
     def __getitem__(self, *args):
         r"""
-        __getitem__(vector_integer_t self, SWIGPY_SLICEOBJECT * slice) -> vector_integer_t
-        __getitem__(vector_integer_t self, std::vector< int >::difference_type i) -> std::vector< int >::value_type const &
+        __getitem__(vector_integer_T self, SWIGPY_SLICEOBJECT * slice) -> vector_integer_T
+        __getitem__(vector_integer_T self, std::vector< int >::difference_type i) -> std::vector< int >::value_type const &
         """
-        return _libBornAgainSample.vector_integer_t___getitem__(self, *args)
+        return _libBornAgainSample.vector_integer_T___getitem__(self, *args)
 
     def __setitem__(self, *args):
         r"""
-        __setitem__(vector_integer_t self, SWIGPY_SLICEOBJECT * slice, vector_integer_t v)
-        __setitem__(vector_integer_t self, SWIGPY_SLICEOBJECT * slice)
-        __setitem__(vector_integer_t self, std::vector< int >::difference_type i, std::vector< int >::value_type const & x)
+        __setitem__(vector_integer_T self, SWIGPY_SLICEOBJECT * slice, vector_integer_T v)
+        __setitem__(vector_integer_T self, SWIGPY_SLICEOBJECT * slice)
+        __setitem__(vector_integer_T self, std::vector< int >::difference_type i, std::vector< int >::value_type const & x)
         """
-        return _libBornAgainSample.vector_integer_t___setitem__(self, *args)
+        return _libBornAgainSample.vector_integer_T___setitem__(self, *args)
 
     def pop(self):
-        r"""pop(vector_integer_t self) -> std::vector< int >::value_type"""
-        return _libBornAgainSample.vector_integer_t_pop(self)
+        r"""pop(vector_integer_T self) -> std::vector< int >::value_type"""
+        return _libBornAgainSample.vector_integer_T_pop(self)
 
     def append(self, x):
-        r"""append(vector_integer_t self, std::vector< int >::value_type const & x)"""
-        return _libBornAgainSample.vector_integer_t_append(self, x)
+        r"""append(vector_integer_T self, std::vector< int >::value_type const & x)"""
+        return _libBornAgainSample.vector_integer_T_append(self, x)
 
     def empty(self):
-        r"""empty(vector_integer_t self) -> bool"""
-        return _libBornAgainSample.vector_integer_t_empty(self)
+        r"""empty(vector_integer_T self) -> bool"""
+        return _libBornAgainSample.vector_integer_T_empty(self)
 
     def size(self):
-        r"""size(vector_integer_t self) -> std::vector< int >::size_type"""
-        return _libBornAgainSample.vector_integer_t_size(self)
+        r"""size(vector_integer_T self) -> std::vector< int >::size_type"""
+        return _libBornAgainSample.vector_integer_T_size(self)
 
     def swap(self, v):
-        r"""swap(vector_integer_t self, vector_integer_t v)"""
-        return _libBornAgainSample.vector_integer_t_swap(self, v)
+        r"""swap(vector_integer_T self, vector_integer_T v)"""
+        return _libBornAgainSample.vector_integer_T_swap(self, v)
 
     def begin(self):
-        r"""begin(vector_integer_t self) -> std::vector< int >::iterator"""
-        return _libBornAgainSample.vector_integer_t_begin(self)
+        r"""begin(vector_integer_T self) -> std::vector< int >::iterator"""
+        return _libBornAgainSample.vector_integer_T_begin(self)
 
     def end(self):
-        r"""end(vector_integer_t self) -> std::vector< int >::iterator"""
-        return _libBornAgainSample.vector_integer_t_end(self)
+        r"""end(vector_integer_T self) -> std::vector< int >::iterator"""
+        return _libBornAgainSample.vector_integer_T_end(self)
 
     def rbegin(self):
-        r"""rbegin(vector_integer_t self) -> std::vector< int >::reverse_iterator"""
-        return _libBornAgainSample.vector_integer_t_rbegin(self)
+        r"""rbegin(vector_integer_T self) -> std::vector< int >::reverse_iterator"""
+        return _libBornAgainSample.vector_integer_T_rbegin(self)
 
     def rend(self):
-        r"""rend(vector_integer_t self) -> std::vector< int >::reverse_iterator"""
-        return _libBornAgainSample.vector_integer_t_rend(self)
+        r"""rend(vector_integer_T self) -> std::vector< int >::reverse_iterator"""
+        return _libBornAgainSample.vector_integer_T_rend(self)
 
     def clear(self):
-        r"""clear(vector_integer_t self)"""
-        return _libBornAgainSample.vector_integer_t_clear(self)
+        r"""clear(vector_integer_T self)"""
+        return _libBornAgainSample.vector_integer_T_clear(self)
 
     def get_allocator(self):
-        r"""get_allocator(vector_integer_t self) -> std::vector< int >::allocator_type"""
-        return _libBornAgainSample.vector_integer_t_get_allocator(self)
+        r"""get_allocator(vector_integer_T self) -> std::vector< int >::allocator_type"""
+        return _libBornAgainSample.vector_integer_T_get_allocator(self)
 
     def pop_back(self):
-        r"""pop_back(vector_integer_t self)"""
-        return _libBornAgainSample.vector_integer_t_pop_back(self)
+        r"""pop_back(vector_integer_T self)"""
+        return _libBornAgainSample.vector_integer_T_pop_back(self)
 
     def erase(self, *args):
         r"""
-        erase(vector_integer_t self, std::vector< int >::iterator pos) -> std::vector< int >::iterator
-        erase(vector_integer_t self, std::vector< int >::iterator first, std::vector< int >::iterator last) -> std::vector< int >::iterator
+        erase(vector_integer_T self, std::vector< int >::iterator pos) -> std::vector< int >::iterator
+        erase(vector_integer_T self, std::vector< int >::iterator first, std::vector< int >::iterator last) -> std::vector< int >::iterator
         """
-        return _libBornAgainSample.vector_integer_t_erase(self, *args)
+        return _libBornAgainSample.vector_integer_T_erase(self, *args)
 
     def __init__(self, *args):
         r"""
-        __init__(vector_integer_t self) -> vector_integer_t
-        __init__(vector_integer_t self, vector_integer_t other) -> vector_integer_t
-        __init__(vector_integer_t self, std::vector< int >::size_type size) -> vector_integer_t
-        __init__(vector_integer_t self, std::vector< int >::size_type size, std::vector< int >::value_type const & value) -> vector_integer_t
+        __init__(vector_integer_T self) -> vector_integer_T
+        __init__(vector_integer_T self, vector_integer_T other) -> vector_integer_T
+        __init__(vector_integer_T self, std::vector< int >::size_type size) -> vector_integer_T
+        __init__(vector_integer_T self, std::vector< int >::size_type size, std::vector< int >::value_type const & value) -> vector_integer_T
         """
-        _libBornAgainSample.vector_integer_t_swiginit(self, _libBornAgainSample.new_vector_integer_t(*args))
+        _libBornAgainSample.vector_integer_T_swiginit(self, _libBornAgainSample.new_vector_integer_T(*args))
 
     def push_back(self, x):
-        r"""push_back(vector_integer_t self, std::vector< int >::value_type const & x)"""
-        return _libBornAgainSample.vector_integer_t_push_back(self, x)
+        r"""push_back(vector_integer_T self, std::vector< int >::value_type const & x)"""
+        return _libBornAgainSample.vector_integer_T_push_back(self, x)
 
     def front(self):
-        r"""front(vector_integer_t self) -> std::vector< int >::value_type const &"""
-        return _libBornAgainSample.vector_integer_t_front(self)
+        r"""front(vector_integer_T self) -> std::vector< int >::value_type const &"""
+        return _libBornAgainSample.vector_integer_T_front(self)
 
     def back(self):
-        r"""back(vector_integer_t self) -> std::vector< int >::value_type const &"""
-        return _libBornAgainSample.vector_integer_t_back(self)
+        r"""back(vector_integer_T self) -> std::vector< int >::value_type const &"""
+        return _libBornAgainSample.vector_integer_T_back(self)
 
     def assign(self, n, x):
-        r"""assign(vector_integer_t self, std::vector< int >::size_type n, std::vector< int >::value_type const & x)"""
-        return _libBornAgainSample.vector_integer_t_assign(self, n, x)
+        r"""assign(vector_integer_T self, std::vector< int >::size_type n, std::vector< int >::value_type const & x)"""
+        return _libBornAgainSample.vector_integer_T_assign(self, n, x)
 
     def resize(self, *args):
         r"""
-        resize(vector_integer_t self, std::vector< int >::size_type new_size)
-        resize(vector_integer_t self, std::vector< int >::size_type new_size, std::vector< int >::value_type const & x)
+        resize(vector_integer_T self, std::vector< int >::size_type new_size)
+        resize(vector_integer_T self, std::vector< int >::size_type new_size, std::vector< int >::value_type const & x)
         """
-        return _libBornAgainSample.vector_integer_t_resize(self, *args)
+        return _libBornAgainSample.vector_integer_T_resize(self, *args)
 
     def insert(self, *args):
         r"""
-        insert(vector_integer_t self, std::vector< int >::iterator pos, std::vector< int >::value_type const & x) -> std::vector< int >::iterator
-        insert(vector_integer_t self, std::vector< int >::iterator pos, std::vector< int >::size_type n, std::vector< int >::value_type const & x)
+        insert(vector_integer_T self, std::vector< int >::iterator pos, std::vector< int >::value_type const & x) -> std::vector< int >::iterator
+        insert(vector_integer_T self, std::vector< int >::iterator pos, std::vector< int >::size_type n, std::vector< int >::value_type const & x)
         """
-        return _libBornAgainSample.vector_integer_t_insert(self, *args)
+        return _libBornAgainSample.vector_integer_T_insert(self, *args)
 
     def reserve(self, n):
-        r"""reserve(vector_integer_t self, std::vector< int >::size_type n)"""
-        return _libBornAgainSample.vector_integer_t_reserve(self, n)
+        r"""reserve(vector_integer_T self, std::vector< int >::size_type n)"""
+        return _libBornAgainSample.vector_integer_T_reserve(self, n)
 
     def capacity(self):
-        r"""capacity(vector_integer_t self) -> std::vector< int >::size_type"""
-        return _libBornAgainSample.vector_integer_t_capacity(self)
-    __swig_destroy__ = _libBornAgainSample.delete_vector_integer_t
+        r"""capacity(vector_integer_T self) -> std::vector< int >::size_type"""
+        return _libBornAgainSample.vector_integer_T_capacity(self)
+    __swig_destroy__ = _libBornAgainSample.delete_vector_integer_T
 
-# Register vector_integer_t in _libBornAgainSample:
-_libBornAgainSample.vector_integer_t_swigregister(vector_integer_t)
-class vinteger2d_t(object):
+# Register vector_integer_T in _libBornAgainSample:
+_libBornAgainSample.vector_integer_T_swigregister(vector_integer_T)
+class vinteger2d_T(object):
     r"""Proxy of C++ std::vector< std::vector< int > > class."""
 
     thisown = property(lambda x: x.this.own(), lambda x, v: x.this.own(v), doc="The membership flag")
     __repr__ = _swig_repr
 
     def iterator(self):
-        r"""iterator(vinteger2d_t self) -> SwigPyIterator"""
-        return _libBornAgainSample.vinteger2d_t_iterator(self)
+        r"""iterator(vinteger2d_T self) -> SwigPyIterator"""
+        return _libBornAgainSample.vinteger2d_T_iterator(self)
     def __iter__(self):
         return self.iterator()
 
     def __nonzero__(self):
-        r"""__nonzero__(vinteger2d_t self) -> bool"""
-        return _libBornAgainSample.vinteger2d_t___nonzero__(self)
+        r"""__nonzero__(vinteger2d_T self) -> bool"""
+        return _libBornAgainSample.vinteger2d_T___nonzero__(self)
 
     def __bool__(self):
-        r"""__bool__(vinteger2d_t self) -> bool"""
-        return _libBornAgainSample.vinteger2d_t___bool__(self)
+        r"""__bool__(vinteger2d_T self) -> bool"""
+        return _libBornAgainSample.vinteger2d_T___bool__(self)
 
     def __len__(self):
-        r"""__len__(vinteger2d_t self) -> std::vector< std::vector< int > >::size_type"""
-        return _libBornAgainSample.vinteger2d_t___len__(self)
+        r"""__len__(vinteger2d_T self) -> std::vector< std::vector< int > >::size_type"""
+        return _libBornAgainSample.vinteger2d_T___len__(self)
 
     def __getslice__(self, i, j):
-        r"""__getslice__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j) -> vinteger2d_t"""
-        return _libBornAgainSample.vinteger2d_t___getslice__(self, i, j)
+        r"""__getslice__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j) -> vinteger2d_T"""
+        return _libBornAgainSample.vinteger2d_T___getslice__(self, i, j)
 
     def __setslice__(self, *args):
         r"""
-        __setslice__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j)
-        __setslice__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j, vinteger2d_t v)
+        __setslice__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j)
+        __setslice__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j, vinteger2d_T v)
         """
-        return _libBornAgainSample.vinteger2d_t___setslice__(self, *args)
+        return _libBornAgainSample.vinteger2d_T___setslice__(self, *args)
 
     def __delslice__(self, i, j):
-        r"""__delslice__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j)"""
-        return _libBornAgainSample.vinteger2d_t___delslice__(self, i, j)
+        r"""__delslice__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j)"""
+        return _libBornAgainSample.vinteger2d_T___delslice__(self, i, j)
 
     def __delitem__(self, *args):
         r"""
-        __delitem__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i)
-        __delitem__(vinteger2d_t self, SWIGPY_SLICEOBJECT * slice)
+        __delitem__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i)
+        __delitem__(vinteger2d_T self, SWIGPY_SLICEOBJECT * slice)
         """
-        return _libBornAgainSample.vinteger2d_t___delitem__(self, *args)
+        return _libBornAgainSample.vinteger2d_T___delitem__(self, *args)
 
     def __getitem__(self, *args):
         r"""
-        __getitem__(vinteger2d_t self, SWIGPY_SLICEOBJECT * slice) -> vinteger2d_t
-        __getitem__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i) -> vector_integer_t
+        __getitem__(vinteger2d_T self, SWIGPY_SLICEOBJECT * slice) -> vinteger2d_T
+        __getitem__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i) -> vector_integer_T
         """
-        return _libBornAgainSample.vinteger2d_t___getitem__(self, *args)
+        return _libBornAgainSample.vinteger2d_T___getitem__(self, *args)
 
     def __setitem__(self, *args):
         r"""
-        __setitem__(vinteger2d_t self, SWIGPY_SLICEOBJECT * slice, vinteger2d_t v)
-        __setitem__(vinteger2d_t self, SWIGPY_SLICEOBJECT * slice)
-        __setitem__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i, vector_integer_t x)
+        __setitem__(vinteger2d_T self, SWIGPY_SLICEOBJECT * slice, vinteger2d_T v)
+        __setitem__(vinteger2d_T self, SWIGPY_SLICEOBJECT * slice)
+        __setitem__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i, vector_integer_T x)
         """
-        return _libBornAgainSample.vinteger2d_t___setitem__(self, *args)
+        return _libBornAgainSample.vinteger2d_T___setitem__(self, *args)
 
     def pop(self):
-        r"""pop(vinteger2d_t self) -> vector_integer_t"""
-        return _libBornAgainSample.vinteger2d_t_pop(self)
+        r"""pop(vinteger2d_T self) -> vector_integer_T"""
+        return _libBornAgainSample.vinteger2d_T_pop(self)
 
     def append(self, x):
-        r"""append(vinteger2d_t self, vector_integer_t x)"""
-        return _libBornAgainSample.vinteger2d_t_append(self, x)
+        r"""append(vinteger2d_T self, vector_integer_T x)"""
+        return _libBornAgainSample.vinteger2d_T_append(self, x)
 
     def empty(self):
-        r"""empty(vinteger2d_t self) -> bool"""
-        return _libBornAgainSample.vinteger2d_t_empty(self)
+        r"""empty(vinteger2d_T self) -> bool"""
+        return _libBornAgainSample.vinteger2d_T_empty(self)
 
     def size(self):
-        r"""size(vinteger2d_t self) -> std::vector< std::vector< int > >::size_type"""
-        return _libBornAgainSample.vinteger2d_t_size(self)
+        r"""size(vinteger2d_T self) -> std::vector< std::vector< int > >::size_type"""
+        return _libBornAgainSample.vinteger2d_T_size(self)
 
     def swap(self, v):
-        r"""swap(vinteger2d_t self, vinteger2d_t v)"""
-        return _libBornAgainSample.vinteger2d_t_swap(self, v)
+        r"""swap(vinteger2d_T self, vinteger2d_T v)"""
+        return _libBornAgainSample.vinteger2d_T_swap(self, v)
 
     def begin(self):
-        r"""begin(vinteger2d_t self) -> std::vector< std::vector< int > >::iterator"""
-        return _libBornAgainSample.vinteger2d_t_begin(self)
+        r"""begin(vinteger2d_T self) -> std::vector< std::vector< int > >::iterator"""
+        return _libBornAgainSample.vinteger2d_T_begin(self)
 
     def end(self):
-        r"""end(vinteger2d_t self) -> std::vector< std::vector< int > >::iterator"""
-        return _libBornAgainSample.vinteger2d_t_end(self)
+        r"""end(vinteger2d_T self) -> std::vector< std::vector< int > >::iterator"""
+        return _libBornAgainSample.vinteger2d_T_end(self)
 
     def rbegin(self):
-        r"""rbegin(vinteger2d_t self) -> std::vector< std::vector< int > >::reverse_iterator"""
-        return _libBornAgainSample.vinteger2d_t_rbegin(self)
+        r"""rbegin(vinteger2d_T self) -> std::vector< std::vector< int > >::reverse_iterator"""
+        return _libBornAgainSample.vinteger2d_T_rbegin(self)
 
     def rend(self):
-        r"""rend(vinteger2d_t self) -> std::vector< std::vector< int > >::reverse_iterator"""
-        return _libBornAgainSample.vinteger2d_t_rend(self)
+        r"""rend(vinteger2d_T self) -> std::vector< std::vector< int > >::reverse_iterator"""
+        return _libBornAgainSample.vinteger2d_T_rend(self)
 
     def clear(self):
-        r"""clear(vinteger2d_t self)"""
-        return _libBornAgainSample.vinteger2d_t_clear(self)
+        r"""clear(vinteger2d_T self)"""
+        return _libBornAgainSample.vinteger2d_T_clear(self)
 
     def get_allocator(self):
-        r"""get_allocator(vinteger2d_t self) -> std::vector< std::vector< int > >::allocator_type"""
-        return _libBornAgainSample.vinteger2d_t_get_allocator(self)
+        r"""get_allocator(vinteger2d_T self) -> std::vector< std::vector< int > >::allocator_type"""
+        return _libBornAgainSample.vinteger2d_T_get_allocator(self)
 
     def pop_back(self):
-        r"""pop_back(vinteger2d_t self)"""
-        return _libBornAgainSample.vinteger2d_t_pop_back(self)
+        r"""pop_back(vinteger2d_T self)"""
+        return _libBornAgainSample.vinteger2d_T_pop_back(self)
 
     def erase(self, *args):
         r"""
-        erase(vinteger2d_t self, std::vector< std::vector< int > >::iterator pos) -> std::vector< std::vector< int > >::iterator
-        erase(vinteger2d_t self, std::vector< std::vector< int > >::iterator first, std::vector< std::vector< int > >::iterator last) -> std::vector< std::vector< int > >::iterator
+        erase(vinteger2d_T self, std::vector< std::vector< int > >::iterator pos) -> std::vector< std::vector< int > >::iterator
+        erase(vinteger2d_T self, std::vector< std::vector< int > >::iterator first, std::vector< std::vector< int > >::iterator last) -> std::vector< std::vector< int > >::iterator
         """
-        return _libBornAgainSample.vinteger2d_t_erase(self, *args)
+        return _libBornAgainSample.vinteger2d_T_erase(self, *args)
 
     def __init__(self, *args):
         r"""
-        __init__(vinteger2d_t self) -> vinteger2d_t
-        __init__(vinteger2d_t self, vinteger2d_t other) -> vinteger2d_t
-        __init__(vinteger2d_t self, std::vector< std::vector< int > >::size_type size) -> vinteger2d_t
-        __init__(vinteger2d_t self, std::vector< std::vector< int > >::size_type size, vector_integer_t value) -> vinteger2d_t
+        __init__(vinteger2d_T self) -> vinteger2d_T
+        __init__(vinteger2d_T self, vinteger2d_T other) -> vinteger2d_T
+        __init__(vinteger2d_T self, std::vector< std::vector< int > >::size_type size) -> vinteger2d_T
+        __init__(vinteger2d_T self, std::vector< std::vector< int > >::size_type size, vector_integer_T value) -> vinteger2d_T
         """
-        _libBornAgainSample.vinteger2d_t_swiginit(self, _libBornAgainSample.new_vinteger2d_t(*args))
+        _libBornAgainSample.vinteger2d_T_swiginit(self, _libBornAgainSample.new_vinteger2d_T(*args))
 
     def push_back(self, x):
-        r"""push_back(vinteger2d_t self, vector_integer_t x)"""
-        return _libBornAgainSample.vinteger2d_t_push_back(self, x)
+        r"""push_back(vinteger2d_T self, vector_integer_T x)"""
+        return _libBornAgainSample.vinteger2d_T_push_back(self, x)
 
     def front(self):
-        r"""front(vinteger2d_t self) -> vector_integer_t"""
-        return _libBornAgainSample.vinteger2d_t_front(self)
+        r"""front(vinteger2d_T self) -> vector_integer_T"""
+        return _libBornAgainSample.vinteger2d_T_front(self)
 
     def back(self):
-        r"""back(vinteger2d_t self) -> vector_integer_t"""
-        return _libBornAgainSample.vinteger2d_t_back(self)
+        r"""back(vinteger2d_T self) -> vector_integer_T"""
+        return _libBornAgainSample.vinteger2d_T_back(self)
 
     def assign(self, n, x):
-        r"""assign(vinteger2d_t self, std::vector< std::vector< int > >::size_type n, vector_integer_t x)"""
-        return _libBornAgainSample.vinteger2d_t_assign(self, n, x)
+        r"""assign(vinteger2d_T self, std::vector< std::vector< int > >::size_type n, vector_integer_T x)"""
+        return _libBornAgainSample.vinteger2d_T_assign(self, n, x)
 
     def resize(self, *args):
         r"""
-        resize(vinteger2d_t self, std::vector< std::vector< int > >::size_type new_size)
-        resize(vinteger2d_t self, std::vector< std::vector< int > >::size_type new_size, vector_integer_t x)
+        resize(vinteger2d_T self, std::vector< std::vector< int > >::size_type new_size)
+        resize(vinteger2d_T self, std::vector< std::vector< int > >::size_type new_size, vector_integer_T x)
         """
-        return _libBornAgainSample.vinteger2d_t_resize(self, *args)
+        return _libBornAgainSample.vinteger2d_T_resize(self, *args)
 
     def insert(self, *args):
         r"""
-        insert(vinteger2d_t self, std::vector< std::vector< int > >::iterator pos, vector_integer_t x) -> std::vector< std::vector< int > >::iterator
-        insert(vinteger2d_t self, std::vector< std::vector< int > >::iterator pos, std::vector< std::vector< int > >::size_type n, vector_integer_t x)
+        insert(vinteger2d_T self, std::vector< std::vector< int > >::iterator pos, vector_integer_T x) -> std::vector< std::vector< int > >::iterator
+        insert(vinteger2d_T self, std::vector< std::vector< int > >::iterator pos, std::vector< std::vector< int > >::size_type n, vector_integer_T x)
         """
-        return _libBornAgainSample.vinteger2d_t_insert(self, *args)
+        return _libBornAgainSample.vinteger2d_T_insert(self, *args)
 
     def reserve(self, n):
-        r"""reserve(vinteger2d_t self, std::vector< std::vector< int > >::size_type n)"""
-        return _libBornAgainSample.vinteger2d_t_reserve(self, n)
+        r"""reserve(vinteger2d_T self, std::vector< std::vector< int > >::size_type n)"""
+        return _libBornAgainSample.vinteger2d_T_reserve(self, n)
 
     def capacity(self):
-        r"""capacity(vinteger2d_t self) -> std::vector< std::vector< int > >::size_type"""
-        return _libBornAgainSample.vinteger2d_t_capacity(self)
-    __swig_destroy__ = _libBornAgainSample.delete_vinteger2d_t
+        r"""capacity(vinteger2d_T self) -> std::vector< std::vector< int > >::size_type"""
+        return _libBornAgainSample.vinteger2d_T_capacity(self)
+    __swig_destroy__ = _libBornAgainSample.delete_vinteger2d_T
 
-# Register vinteger2d_t in _libBornAgainSample:
-_libBornAgainSample.vinteger2d_t_swigregister(vinteger2d_t)
-class vector_longinteger_t(object):
+# Register vinteger2d_T in _libBornAgainSample:
+_libBornAgainSample.vinteger2d_T_swigregister(vinteger2d_T)
+class vector_longinteger_T(object):
     r"""Proxy of C++ std::vector< unsigned long > class."""
 
     thisown = property(lambda x: x.this.own(), lambda x, v: x.this.own(v), doc="The membership flag")
     __repr__ = _swig_repr
 
     def iterator(self):
-        r"""iterator(vector_longinteger_t self) -> SwigPyIterator"""
-        return _libBornAgainSample.vector_longinteger_t_iterator(self)
+        r"""iterator(vector_longinteger_T self) -> SwigPyIterator"""
+        return _libBornAgainSample.vector_longinteger_T_iterator(self)
     def __iter__(self):
         return self.iterator()
 
     def __nonzero__(self):
-        r"""__nonzero__(vector_longinteger_t self) -> bool"""
-        return _libBornAgainSample.vector_longinteger_t___nonzero__(self)
+        r"""__nonzero__(vector_longinteger_T self) -> bool"""
+        return _libBornAgainSample.vector_longinteger_T___nonzero__(self)
 
     def __bool__(self):
-        r"""__bool__(vector_longinteger_t self) -> bool"""
-        return _libBornAgainSample.vector_longinteger_t___bool__(self)
+        r"""__bool__(vector_longinteger_T self) -> bool"""
+        return _libBornAgainSample.vector_longinteger_T___bool__(self)
 
     def __len__(self):
-        r"""__len__(vector_longinteger_t self) -> std::vector< unsigned long >::size_type"""
-        return _libBornAgainSample.vector_longinteger_t___len__(self)
+        r"""__len__(vector_longinteger_T self) -> std::vector< unsigned long >::size_type"""
+        return _libBornAgainSample.vector_longinteger_T___len__(self)
 
     def __getslice__(self, i, j):
-        r"""__getslice__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j) -> vector_longinteger_t"""
-        return _libBornAgainSample.vector_longinteger_t___getslice__(self, i, j)
+        r"""__getslice__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j) -> vector_longinteger_T"""
+        return _libBornAgainSample.vector_longinteger_T___getslice__(self, i, j)
 
     def __setslice__(self, *args):
         r"""
-        __setslice__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j)
-        __setslice__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j, vector_longinteger_t v)
+        __setslice__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j)
+        __setslice__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j, vector_longinteger_T v)
         """
-        return _libBornAgainSample.vector_longinteger_t___setslice__(self, *args)
+        return _libBornAgainSample.vector_longinteger_T___setslice__(self, *args)
 
     def __delslice__(self, i, j):
-        r"""__delslice__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j)"""
-        return _libBornAgainSample.vector_longinteger_t___delslice__(self, i, j)
+        r"""__delslice__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j)"""
+        return _libBornAgainSample.vector_longinteger_T___delslice__(self, i, j)
 
     def __delitem__(self, *args):
         r"""
-        __delitem__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i)
-        __delitem__(vector_longinteger_t self, SWIGPY_SLICEOBJECT * slice)
+        __delitem__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i)
+        __delitem__(vector_longinteger_T self, SWIGPY_SLICEOBJECT * slice)
         """
-        return _libBornAgainSample.vector_longinteger_t___delitem__(self, *args)
+        return _libBornAgainSample.vector_longinteger_T___delitem__(self, *args)
 
     def __getitem__(self, *args):
         r"""
-        __getitem__(vector_longinteger_t self, SWIGPY_SLICEOBJECT * slice) -> vector_longinteger_t
-        __getitem__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i) -> std::vector< unsigned long >::value_type const &
+        __getitem__(vector_longinteger_T self, SWIGPY_SLICEOBJECT * slice) -> vector_longinteger_T
+        __getitem__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i) -> std::vector< unsigned long >::value_type const &
         """
-        return _libBornAgainSample.vector_longinteger_t___getitem__(self, *args)
+        return _libBornAgainSample.vector_longinteger_T___getitem__(self, *args)
 
     def __setitem__(self, *args):
         r"""
-        __setitem__(vector_longinteger_t self, SWIGPY_SLICEOBJECT * slice, vector_longinteger_t v)
-        __setitem__(vector_longinteger_t self, SWIGPY_SLICEOBJECT * slice)
-        __setitem__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::value_type const & x)
+        __setitem__(vector_longinteger_T self, SWIGPY_SLICEOBJECT * slice, vector_longinteger_T v)
+        __setitem__(vector_longinteger_T self, SWIGPY_SLICEOBJECT * slice)
+        __setitem__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::value_type const & x)
         """
-        return _libBornAgainSample.vector_longinteger_t___setitem__(self, *args)
+        return _libBornAgainSample.vector_longinteger_T___setitem__(self, *args)
 
     def pop(self):
-        r"""pop(vector_longinteger_t self) -> std::vector< unsigned long >::value_type"""
-        return _libBornAgainSample.vector_longinteger_t_pop(self)
+        r"""pop(vector_longinteger_T self) -> std::vector< unsigned long >::value_type"""
+        return _libBornAgainSample.vector_longinteger_T_pop(self)
 
     def append(self, x):
-        r"""append(vector_longinteger_t self, std::vector< unsigned long >::value_type const & x)"""
-        return _libBornAgainSample.vector_longinteger_t_append(self, x)
+        r"""append(vector_longinteger_T self, std::vector< unsigned long >::value_type const & x)"""
+        return _libBornAgainSample.vector_longinteger_T_append(self, x)
 
     def empty(self):
-        r"""empty(vector_longinteger_t self) -> bool"""
-        return _libBornAgainSample.vector_longinteger_t_empty(self)
+        r"""empty(vector_longinteger_T self) -> bool"""
+        return _libBornAgainSample.vector_longinteger_T_empty(self)
 
     def size(self):
-        r"""size(vector_longinteger_t self) -> std::vector< unsigned long >::size_type"""
-        return _libBornAgainSample.vector_longinteger_t_size(self)
+        r"""size(vector_longinteger_T self) -> std::vector< unsigned long >::size_type"""
+        return _libBornAgainSample.vector_longinteger_T_size(self)
 
     def swap(self, v):
-        r"""swap(vector_longinteger_t self, vector_longinteger_t v)"""
-        return _libBornAgainSample.vector_longinteger_t_swap(self, v)
+        r"""swap(vector_longinteger_T self, vector_longinteger_T v)"""
+        return _libBornAgainSample.vector_longinteger_T_swap(self, v)
 
     def begin(self):
-        r"""begin(vector_longinteger_t self) -> std::vector< unsigned long >::iterator"""
-        return _libBornAgainSample.vector_longinteger_t_begin(self)
+        r"""begin(vector_longinteger_T self) -> std::vector< unsigned long >::iterator"""
+        return _libBornAgainSample.vector_longinteger_T_begin(self)
 
     def end(self):
-        r"""end(vector_longinteger_t self) -> std::vector< unsigned long >::iterator"""
-        return _libBornAgainSample.vector_longinteger_t_end(self)
+        r"""end(vector_longinteger_T self) -> std::vector< unsigned long >::iterator"""
+        return _libBornAgainSample.vector_longinteger_T_end(self)
 
     def rbegin(self):
-        r"""rbegin(vector_longinteger_t self) -> std::vector< unsigned long >::reverse_iterator"""
-        return _libBornAgainSample.vector_longinteger_t_rbegin(self)
+        r"""rbegin(vector_longinteger_T self) -> std::vector< unsigned long >::reverse_iterator"""
+        return _libBornAgainSample.vector_longinteger_T_rbegin(self)
 
     def rend(self):
-        r"""rend(vector_longinteger_t self) -> std::vector< unsigned long >::reverse_iterator"""
-        return _libBornAgainSample.vector_longinteger_t_rend(self)
+        r"""rend(vector_longinteger_T self) -> std::vector< unsigned long >::reverse_iterator"""
+        return _libBornAgainSample.vector_longinteger_T_rend(self)
 
     def clear(self):
-        r"""clear(vector_longinteger_t self)"""
-        return _libBornAgainSample.vector_longinteger_t_clear(self)
+        r"""clear(vector_longinteger_T self)"""
+        return _libBornAgainSample.vector_longinteger_T_clear(self)
 
     def get_allocator(self):
-        r"""get_allocator(vector_longinteger_t self) -> std::vector< unsigned long >::allocator_type"""
-        return _libBornAgainSample.vector_longinteger_t_get_allocator(self)
+        r"""get_allocator(vector_longinteger_T self) -> std::vector< unsigned long >::allocator_type"""
+        return _libBornAgainSample.vector_longinteger_T_get_allocator(self)
 
     def pop_back(self):
-        r"""pop_back(vector_longinteger_t self)"""
-        return _libBornAgainSample.vector_longinteger_t_pop_back(self)
+        r"""pop_back(vector_longinteger_T self)"""
+        return _libBornAgainSample.vector_longinteger_T_pop_back(self)
 
     def erase(self, *args):
         r"""
-        erase(vector_longinteger_t self, std::vector< unsigned long >::iterator pos) -> std::vector< unsigned long >::iterator
-        erase(vector_longinteger_t self, std::vector< unsigned long >::iterator first, std::vector< unsigned long >::iterator last) -> std::vector< unsigned long >::iterator
+        erase(vector_longinteger_T self, std::vector< unsigned long >::iterator pos) -> std::vector< unsigned long >::iterator
+        erase(vector_longinteger_T self, std::vector< unsigned long >::iterator first, std::vector< unsigned long >::iterator last) -> std::vector< unsigned long >::iterator
         """
-        return _libBornAgainSample.vector_longinteger_t_erase(self, *args)
+        return _libBornAgainSample.vector_longinteger_T_erase(self, *args)
 
     def __init__(self, *args):
         r"""
-        __init__(vector_longinteger_t self) -> vector_longinteger_t
-        __init__(vector_longinteger_t self, vector_longinteger_t other) -> vector_longinteger_t
-        __init__(vector_longinteger_t self, std::vector< unsigned long >::size_type size) -> vector_longinteger_t
-        __init__(vector_longinteger_t self, std::vector< unsigned long >::size_type size, std::vector< unsigned long >::value_type const & value) -> vector_longinteger_t
+        __init__(vector_longinteger_T self) -> vector_longinteger_T
+        __init__(vector_longinteger_T self, vector_longinteger_T other) -> vector_longinteger_T
+        __init__(vector_longinteger_T self, std::vector< unsigned long >::size_type size) -> vector_longinteger_T
+        __init__(vector_longinteger_T self, std::vector< unsigned long >::size_type size, std::vector< unsigned long >::value_type const & value) -> vector_longinteger_T
         """
-        _libBornAgainSample.vector_longinteger_t_swiginit(self, _libBornAgainSample.new_vector_longinteger_t(*args))
+        _libBornAgainSample.vector_longinteger_T_swiginit(self, _libBornAgainSample.new_vector_longinteger_T(*args))
 
     def push_back(self, x):
-        r"""push_back(vector_longinteger_t self, std::vector< unsigned long >::value_type const & x)"""
-        return _libBornAgainSample.vector_longinteger_t_push_back(self, x)
+        r"""push_back(vector_longinteger_T self, std::vector< unsigned long >::value_type const & x)"""
+        return _libBornAgainSample.vector_longinteger_T_push_back(self, x)
 
     def front(self):
-        r"""front(vector_longinteger_t self) -> std::vector< unsigned long >::value_type const &"""
-        return _libBornAgainSample.vector_longinteger_t_front(self)
+        r"""front(vector_longinteger_T self) -> std::vector< unsigned long >::value_type const &"""
+        return _libBornAgainSample.vector_longinteger_T_front(self)
 
     def back(self):
-        r"""back(vector_longinteger_t self) -> std::vector< unsigned long >::value_type const &"""
-        return _libBornAgainSample.vector_longinteger_t_back(self)
+        r"""back(vector_longinteger_T self) -> std::vector< unsigned long >::value_type const &"""
+        return _libBornAgainSample.vector_longinteger_T_back(self)
 
     def assign(self, n, x):
-        r"""assign(vector_longinteger_t self, std::vector< unsigned long >::size_type n, std::vector< unsigned long >::value_type const & x)"""
-        return _libBornAgainSample.vector_longinteger_t_assign(self, n, x)
+        r"""assign(vector_longinteger_T self, std::vector< unsigned long >::size_type n, std::vector< unsigned long >::value_type const & x)"""
+        return _libBornAgainSample.vector_longinteger_T_assign(self, n, x)
 
     def resize(self, *args):
         r"""
-        resize(vector_longinteger_t self, std::vector< unsigned long >::size_type new_size)
-        resize(vector_longinteger_t self, std::vector< unsigned long >::size_type new_size, std::vector< unsigned long >::value_type const & x)
+        resize(vector_longinteger_T self, std::vector< unsigned long >::size_type new_size)
+        resize(vector_longinteger_T self, std::vector< unsigned long >::size_type new_size, std::vector< unsigned long >::value_type const & x)
         """
-        return _libBornAgainSample.vector_longinteger_t_resize(self, *args)
+        return _libBornAgainSample.vector_longinteger_T_resize(self, *args)
 
     def insert(self, *args):
         r"""
-        insert(vector_longinteger_t self, std::vector< unsigned long >::iterator pos, std::vector< unsigned long >::value_type const & x) -> std::vector< unsigned long >::iterator
-        insert(vector_longinteger_t self, std::vector< unsigned long >::iterator pos, std::vector< unsigned long >::size_type n, std::vector< unsigned long >::value_type const & x)
+        insert(vector_longinteger_T self, std::vector< unsigned long >::iterator pos, std::vector< unsigned long >::value_type const & x) -> std::vector< unsigned long >::iterator
+        insert(vector_longinteger_T self, std::vector< unsigned long >::iterator pos, std::vector< unsigned long >::size_type n, std::vector< unsigned long >::value_type const & x)
         """
-        return _libBornAgainSample.vector_longinteger_t_insert(self, *args)
+        return _libBornAgainSample.vector_longinteger_T_insert(self, *args)
 
     def reserve(self, n):
-        r"""reserve(vector_longinteger_t self, std::vector< unsigned long >::size_type n)"""
-        return _libBornAgainSample.vector_longinteger_t_reserve(self, n)
+        r"""reserve(vector_longinteger_T self, std::vector< unsigned long >::size_type n)"""
+        return _libBornAgainSample.vector_longinteger_T_reserve(self, n)
 
     def capacity(self):
-        r"""capacity(vector_longinteger_t self) -> std::vector< unsigned long >::size_type"""
-        return _libBornAgainSample.vector_longinteger_t_capacity(self)
-    __swig_destroy__ = _libBornAgainSample.delete_vector_longinteger_t
+        r"""capacity(vector_longinteger_T self) -> std::vector< unsigned long >::size_type"""
+        return _libBornAgainSample.vector_longinteger_T_capacity(self)
+    __swig_destroy__ = _libBornAgainSample.delete_vector_longinteger_T
 
-# Register vector_longinteger_t in _libBornAgainSample:
-_libBornAgainSample.vector_longinteger_t_swigregister(vector_longinteger_t)
-class vector_complex_t(object):
+# Register vector_longinteger_T in _libBornAgainSample:
+_libBornAgainSample.vector_longinteger_T_swigregister(vector_longinteger_T)
+class vector_complex_T(object):
     r"""Proxy of C++ std::vector< std::complex< double > > class."""
 
     thisown = property(lambda x: x.this.own(), lambda x, v: x.this.own(v), doc="The membership flag")
     __repr__ = _swig_repr
 
     def iterator(self):
-        r"""iterator(vector_complex_t self) -> SwigPyIterator"""
-        return _libBornAgainSample.vector_complex_t_iterator(self)
+        r"""iterator(vector_complex_T self) -> SwigPyIterator"""
+        return _libBornAgainSample.vector_complex_T_iterator(self)
     def __iter__(self):
         return self.iterator()
 
     def __nonzero__(self):
-        r"""__nonzero__(vector_complex_t self) -> bool"""
-        return _libBornAgainSample.vector_complex_t___nonzero__(self)
+        r"""__nonzero__(vector_complex_T self) -> bool"""
+        return _libBornAgainSample.vector_complex_T___nonzero__(self)
 
     def __bool__(self):
-        r"""__bool__(vector_complex_t self) -> bool"""
-        return _libBornAgainSample.vector_complex_t___bool__(self)
+        r"""__bool__(vector_complex_T self) -> bool"""
+        return _libBornAgainSample.vector_complex_T___bool__(self)
 
     def __len__(self):
-        r"""__len__(vector_complex_t self) -> std::vector< std::complex< double > >::size_type"""
-        return _libBornAgainSample.vector_complex_t___len__(self)
+        r"""__len__(vector_complex_T self) -> std::vector< std::complex< double > >::size_type"""
+        return _libBornAgainSample.vector_complex_T___len__(self)
 
     def __getslice__(self, i, j):
-        r"""__getslice__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j) -> vector_complex_t"""
-        return _libBornAgainSample.vector_complex_t___getslice__(self, i, j)
+        r"""__getslice__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j) -> vector_complex_T"""
+        return _libBornAgainSample.vector_complex_T___getslice__(self, i, j)
 
     def __setslice__(self, *args):
         r"""
-        __setslice__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j)
-        __setslice__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j, vector_complex_t v)
+        __setslice__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j)
+        __setslice__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j, vector_complex_T v)
         """
-        return _libBornAgainSample.vector_complex_t___setslice__(self, *args)
+        return _libBornAgainSample.vector_complex_T___setslice__(self, *args)
 
     def __delslice__(self, i, j):
-        r"""__delslice__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j)"""
-        return _libBornAgainSample.vector_complex_t___delslice__(self, i, j)
+        r"""__delslice__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j)"""
+        return _libBornAgainSample.vector_complex_T___delslice__(self, i, j)
 
     def __delitem__(self, *args):
         r"""
-        __delitem__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i)
-        __delitem__(vector_complex_t self, SWIGPY_SLICEOBJECT * slice)
+        __delitem__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i)
+        __delitem__(vector_complex_T self, SWIGPY_SLICEOBJECT * slice)
         """
-        return _libBornAgainSample.vector_complex_t___delitem__(self, *args)
+        return _libBornAgainSample.vector_complex_T___delitem__(self, *args)
 
     def __getitem__(self, *args):
         r"""
-        __getitem__(vector_complex_t self, SWIGPY_SLICEOBJECT * slice) -> vector_complex_t
-        __getitem__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i) -> std::vector< std::complex< double > >::value_type const &
+        __getitem__(vector_complex_T self, SWIGPY_SLICEOBJECT * slice) -> vector_complex_T
+        __getitem__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i) -> std::vector< std::complex< double > >::value_type const &
         """
-        return _libBornAgainSample.vector_complex_t___getitem__(self, *args)
+        return _libBornAgainSample.vector_complex_T___getitem__(self, *args)
 
     def __setitem__(self, *args):
         r"""
-        __setitem__(vector_complex_t self, SWIGPY_SLICEOBJECT * slice, vector_complex_t v)
-        __setitem__(vector_complex_t self, SWIGPY_SLICEOBJECT * slice)
-        __setitem__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::value_type const & x)
+        __setitem__(vector_complex_T self, SWIGPY_SLICEOBJECT * slice, vector_complex_T v)
+        __setitem__(vector_complex_T self, SWIGPY_SLICEOBJECT * slice)
+        __setitem__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::value_type const & x)
         """
-        return _libBornAgainSample.vector_complex_t___setitem__(self, *args)
+        return _libBornAgainSample.vector_complex_T___setitem__(self, *args)
 
     def pop(self):
-        r"""pop(vector_complex_t self) -> std::vector< std::complex< double > >::value_type"""
-        return _libBornAgainSample.vector_complex_t_pop(self)
+        r"""pop(vector_complex_T self) -> std::vector< std::complex< double > >::value_type"""
+        return _libBornAgainSample.vector_complex_T_pop(self)
 
     def append(self, x):
-        r"""append(vector_complex_t self, std::vector< std::complex< double > >::value_type const & x)"""
-        return _libBornAgainSample.vector_complex_t_append(self, x)
+        r"""append(vector_complex_T self, std::vector< std::complex< double > >::value_type const & x)"""
+        return _libBornAgainSample.vector_complex_T_append(self, x)
 
     def empty(self):
-        r"""empty(vector_complex_t self) -> bool"""
-        return _libBornAgainSample.vector_complex_t_empty(self)
+        r"""empty(vector_complex_T self) -> bool"""
+        return _libBornAgainSample.vector_complex_T_empty(self)
 
     def size(self):
-        r"""size(vector_complex_t self) -> std::vector< std::complex< double > >::size_type"""
-        return _libBornAgainSample.vector_complex_t_size(self)
+        r"""size(vector_complex_T self) -> std::vector< std::complex< double > >::size_type"""
+        return _libBornAgainSample.vector_complex_T_size(self)
 
     def swap(self, v):
-        r"""swap(vector_complex_t self, vector_complex_t v)"""
-        return _libBornAgainSample.vector_complex_t_swap(self, v)
+        r"""swap(vector_complex_T self, vector_complex_T v)"""
+        return _libBornAgainSample.vector_complex_T_swap(self, v)
 
     def begin(self):
-        r"""begin(vector_complex_t self) -> std::vector< std::complex< double > >::iterator"""
-        return _libBornAgainSample.vector_complex_t_begin(self)
+        r"""begin(vector_complex_T self) -> std::vector< std::complex< double > >::iterator"""
+        return _libBornAgainSample.vector_complex_T_begin(self)
 
     def end(self):
-        r"""end(vector_complex_t self) -> std::vector< std::complex< double > >::iterator"""
-        return _libBornAgainSample.vector_complex_t_end(self)
+        r"""end(vector_complex_T self) -> std::vector< std::complex< double > >::iterator"""
+        return _libBornAgainSample.vector_complex_T_end(self)
 
     def rbegin(self):
-        r"""rbegin(vector_complex_t self) -> std::vector< std::complex< double > >::reverse_iterator"""
-        return _libBornAgainSample.vector_complex_t_rbegin(self)
+        r"""rbegin(vector_complex_T self) -> std::vector< std::complex< double > >::reverse_iterator"""
+        return _libBornAgainSample.vector_complex_T_rbegin(self)
 
     def rend(self):
-        r"""rend(vector_complex_t self) -> std::vector< std::complex< double > >::reverse_iterator"""
-        return _libBornAgainSample.vector_complex_t_rend(self)
+        r"""rend(vector_complex_T self) -> std::vector< std::complex< double > >::reverse_iterator"""
+        return _libBornAgainSample.vector_complex_T_rend(self)
 
     def clear(self):
-        r"""clear(vector_complex_t self)"""
-        return _libBornAgainSample.vector_complex_t_clear(self)
+        r"""clear(vector_complex_T self)"""
+        return _libBornAgainSample.vector_complex_T_clear(self)
 
     def get_allocator(self):
-        r"""get_allocator(vector_complex_t self) -> std::vector< std::complex< double > >::allocator_type"""
-        return _libBornAgainSample.vector_complex_t_get_allocator(self)
+        r"""get_allocator(vector_complex_T self) -> std::vector< std::complex< double > >::allocator_type"""
+        return _libBornAgainSample.vector_complex_T_get_allocator(self)
 
     def pop_back(self):
-        r"""pop_back(vector_complex_t self)"""
-        return _libBornAgainSample.vector_complex_t_pop_back(self)
+        r"""pop_back(vector_complex_T self)"""
+        return _libBornAgainSample.vector_complex_T_pop_back(self)
 
     def erase(self, *args):
         r"""
-        erase(vector_complex_t self, std::vector< std::complex< double > >::iterator pos) -> std::vector< std::complex< double > >::iterator
-        erase(vector_complex_t self, std::vector< std::complex< double > >::iterator first, std::vector< std::complex< double > >::iterator last) -> std::vector< std::complex< double > >::iterator
+        erase(vector_complex_T self, std::vector< std::complex< double > >::iterator pos) -> std::vector< std::complex< double > >::iterator
+        erase(vector_complex_T self, std::vector< std::complex< double > >::iterator first, std::vector< std::complex< double > >::iterator last) -> std::vector< std::complex< double > >::iterator
         """
-        return _libBornAgainSample.vector_complex_t_erase(self, *args)
+        return _libBornAgainSample.vector_complex_T_erase(self, *args)
 
     def __init__(self, *args):
         r"""
-        __init__(vector_complex_t self) -> vector_complex_t
-        __init__(vector_complex_t self, vector_complex_t other) -> vector_complex_t
-        __init__(vector_complex_t self, std::vector< std::complex< double > >::size_type size) -> vector_complex_t
-        __init__(vector_complex_t self, std::vector< std::complex< double > >::size_type size, std::vector< std::complex< double > >::value_type const & value) -> vector_complex_t
+        __init__(vector_complex_T self) -> vector_complex_T
+        __init__(vector_complex_T self, vector_complex_T other) -> vector_complex_T
+        __init__(vector_complex_T self, std::vector< std::complex< double > >::size_type size) -> vector_complex_T
+        __init__(vector_complex_T self, std::vector< std::complex< double > >::size_type size, std::vector< std::complex< double > >::value_type const & value) -> vector_complex_T
         """
-        _libBornAgainSample.vector_complex_t_swiginit(self, _libBornAgainSample.new_vector_complex_t(*args))
+        _libBornAgainSample.vector_complex_T_swiginit(self, _libBornAgainSample.new_vector_complex_T(*args))
 
     def push_back(self, x):
-        r"""push_back(vector_complex_t self, std::vector< std::complex< double > >::value_type const & x)"""
-        return _libBornAgainSample.vector_complex_t_push_back(self, x)
+        r"""push_back(vector_complex_T self, std::vector< std::complex< double > >::value_type const & x)"""
+        return _libBornAgainSample.vector_complex_T_push_back(self, x)
 
     def front(self):
-        r"""front(vector_complex_t self) -> std::vector< std::complex< double > >::value_type const &"""
-        return _libBornAgainSample.vector_complex_t_front(self)
+        r"""front(vector_complex_T self) -> std::vector< std::complex< double > >::value_type const &"""
+        return _libBornAgainSample.vector_complex_T_front(self)
 
     def back(self):
-        r"""back(vector_complex_t self) -> std::vector< std::complex< double > >::value_type const &"""
-        return _libBornAgainSample.vector_complex_t_back(self)
+        r"""back(vector_complex_T self) -> std::vector< std::complex< double > >::value_type const &"""
+        return _libBornAgainSample.vector_complex_T_back(self)
 
     def assign(self, n, x):
-        r"""assign(vector_complex_t self, std::vector< std::complex< double > >::size_type n, std::vector< std::complex< double > >::value_type const & x)"""
-        return _libBornAgainSample.vector_complex_t_assign(self, n, x)
+        r"""assign(vector_complex_T self, std::vector< std::complex< double > >::size_type n, std::vector< std::complex< double > >::value_type const & x)"""
+        return _libBornAgainSample.vector_complex_T_assign(self, n, x)
 
     def resize(self, *args):
         r"""
-        resize(vector_complex_t self, std::vector< std::complex< double > >::size_type new_size)
-        resize(vector_complex_t self, std::vector< std::complex< double > >::size_type new_size, std::vector< std::complex< double > >::value_type const & x)
+        resize(vector_complex_T self, std::vector< std::complex< double > >::size_type new_size)
+        resize(vector_complex_T self, std::vector< std::complex< double > >::size_type new_size, std::vector< std::complex< double > >::value_type const & x)
         """
-        return _libBornAgainSample.vector_complex_t_resize(self, *args)
+        return _libBornAgainSample.vector_complex_T_resize(self, *args)
 
     def insert(self, *args):
         r"""
-        insert(vector_complex_t self, std::vector< std::complex< double > >::iterator pos, std::vector< std::complex< double > >::value_type const & x) -> std::vector< std::complex< double > >::iterator
-        insert(vector_complex_t self, std::vector< std::complex< double > >::iterator pos, std::vector< std::complex< double > >::size_type n, std::vector< std::complex< double > >::value_type const & x)
+        insert(vector_complex_T self, std::vector< std::complex< double > >::iterator pos, std::vector< std::complex< double > >::value_type const & x) -> std::vector< std::complex< double > >::iterator
+        insert(vector_complex_T self, std::vector< std::complex< double > >::iterator pos, std::vector< std::complex< double > >::size_type n, std::vector< std::complex< double > >::value_type const & x)
         """
-        return _libBornAgainSample.vector_complex_t_insert(self, *args)
+        return _libBornAgainSample.vector_complex_T_insert(self, *args)
 
     def reserve(self, n):
-        r"""reserve(vector_complex_t self, std::vector< std::complex< double > >::size_type n)"""
-        return _libBornAgainSample.vector_complex_t_reserve(self, n)
+        r"""reserve(vector_complex_T self, std::vector< std::complex< double > >::size_type n)"""
+        return _libBornAgainSample.vector_complex_T_reserve(self, n)
 
     def capacity(self):
-        r"""capacity(vector_complex_t self) -> std::vector< std::complex< double > >::size_type"""
-        return _libBornAgainSample.vector_complex_t_capacity(self)
-    __swig_destroy__ = _libBornAgainSample.delete_vector_complex_t
+        r"""capacity(vector_complex_T self) -> std::vector< std::complex< double > >::size_type"""
+        return _libBornAgainSample.vector_complex_T_capacity(self)
+    __swig_destroy__ = _libBornAgainSample.delete_vector_complex_T
 
-# Register vector_complex_t in _libBornAgainSample:
-_libBornAgainSample.vector_complex_t_swigregister(vector_complex_t)
-class vector_string_t(object):
+# Register vector_complex_T in _libBornAgainSample:
+_libBornAgainSample.vector_complex_T_swigregister(vector_complex_T)
+class vector_string_T(object):
     r"""Proxy of C++ std::vector< std::string > class."""
 
     thisown = property(lambda x: x.this.own(), lambda x, v: x.this.own(v), doc="The membership flag")
     __repr__ = _swig_repr
 
     def iterator(self):
-        r"""iterator(vector_string_t self) -> SwigPyIterator"""
-        return _libBornAgainSample.vector_string_t_iterator(self)
+        r"""iterator(vector_string_T self) -> SwigPyIterator"""
+        return _libBornAgainSample.vector_string_T_iterator(self)
     def __iter__(self):
         return self.iterator()
 
     def __nonzero__(self):
-        r"""__nonzero__(vector_string_t self) -> bool"""
-        return _libBornAgainSample.vector_string_t___nonzero__(self)
+        r"""__nonzero__(vector_string_T self) -> bool"""
+        return _libBornAgainSample.vector_string_T___nonzero__(self)
 
     def __bool__(self):
-        r"""__bool__(vector_string_t self) -> bool"""
-        return _libBornAgainSample.vector_string_t___bool__(self)
+        r"""__bool__(vector_string_T self) -> bool"""
+        return _libBornAgainSample.vector_string_T___bool__(self)
 
     def __len__(self):
-        r"""__len__(vector_string_t self) -> std::vector< std::string >::size_type"""
-        return _libBornAgainSample.vector_string_t___len__(self)
+        r"""__len__(vector_string_T self) -> std::vector< std::string >::size_type"""
+        return _libBornAgainSample.vector_string_T___len__(self)
 
     def __getslice__(self, i, j):
-        r"""__getslice__(vector_string_t self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j) -> vector_string_t"""
-        return _libBornAgainSample.vector_string_t___getslice__(self, i, j)
+        r"""__getslice__(vector_string_T self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j) -> vector_string_T"""
+        return _libBornAgainSample.vector_string_T___getslice__(self, i, j)
 
     def __setslice__(self, *args):
         r"""
-        __setslice__(vector_string_t self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j)
-        __setslice__(vector_string_t self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j, vector_string_t v)
+        __setslice__(vector_string_T self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j)
+        __setslice__(vector_string_T self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j, vector_string_T v)
         """
-        return _libBornAgainSample.vector_string_t___setslice__(self, *args)
+        return _libBornAgainSample.vector_string_T___setslice__(self, *args)
 
     def __delslice__(self, i, j):
-        r"""__delslice__(vector_string_t self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j)"""
-        return _libBornAgainSample.vector_string_t___delslice__(self, i, j)
+        r"""__delslice__(vector_string_T self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j)"""
+        return _libBornAgainSample.vector_string_T___delslice__(self, i, j)
 
     def __delitem__(self, *args):
         r"""
-        __delitem__(vector_string_t self, std::vector< std::string >::difference_type i)
-        __delitem__(vector_string_t self, SWIGPY_SLICEOBJECT * slice)
+        __delitem__(vector_string_T self, std::vector< std::string >::difference_type i)
+        __delitem__(vector_string_T self, SWIGPY_SLICEOBJECT * slice)
         """
-        return _libBornAgainSample.vector_string_t___delitem__(self, *args)
+        return _libBornAgainSample.vector_string_T___delitem__(self, *args)
 
     def __getitem__(self, *args):
         r"""
-        __getitem__(vector_string_t self, SWIGPY_SLICEOBJECT * slice) -> vector_string_t
-        __getitem__(vector_string_t self, std::vector< std::string >::difference_type i) -> std::vector< std::string >::value_type const &
+        __getitem__(vector_string_T self, SWIGPY_SLICEOBJECT * slice) -> vector_string_T
+        __getitem__(vector_string_T self, std::vector< std::string >::difference_type i) -> std::vector< std::string >::value_type const &
         """
-        return _libBornAgainSample.vector_string_t___getitem__(self, *args)
+        return _libBornAgainSample.vector_string_T___getitem__(self, *args)
 
     def __setitem__(self, *args):
         r"""
-        __setitem__(vector_string_t self, SWIGPY_SLICEOBJECT * slice, vector_string_t v)
-        __setitem__(vector_string_t self, SWIGPY_SLICEOBJECT * slice)
-        __setitem__(vector_string_t self, std::vector< std::string >::difference_type i, std::vector< std::string >::value_type const & x)
+        __setitem__(vector_string_T self, SWIGPY_SLICEOBJECT * slice, vector_string_T v)
+        __setitem__(vector_string_T self, SWIGPY_SLICEOBJECT * slice)
+        __setitem__(vector_string_T self, std::vector< std::string >::difference_type i, std::vector< std::string >::value_type const & x)
         """
-        return _libBornAgainSample.vector_string_t___setitem__(self, *args)
+        return _libBornAgainSample.vector_string_T___setitem__(self, *args)
 
     def pop(self):
-        r"""pop(vector_string_t self) -> std::vector< std::string >::value_type"""
-        return _libBornAgainSample.vector_string_t_pop(self)
+        r"""pop(vector_string_T self) -> std::vector< std::string >::value_type"""
+        return _libBornAgainSample.vector_string_T_pop(self)
 
     def append(self, x):
-        r"""append(vector_string_t self, std::vector< std::string >::value_type const & x)"""
-        return _libBornAgainSample.vector_string_t_append(self, x)
+        r"""append(vector_string_T self, std::vector< std::string >::value_type const & x)"""
+        return _libBornAgainSample.vector_string_T_append(self, x)
 
     def empty(self):
-        r"""empty(vector_string_t self) -> bool"""
-        return _libBornAgainSample.vector_string_t_empty(self)
+        r"""empty(vector_string_T self) -> bool"""
+        return _libBornAgainSample.vector_string_T_empty(self)
 
     def size(self):
-        r"""size(vector_string_t self) -> std::vector< std::string >::size_type"""
-        return _libBornAgainSample.vector_string_t_size(self)
+        r"""size(vector_string_T self) -> std::vector< std::string >::size_type"""
+        return _libBornAgainSample.vector_string_T_size(self)
 
     def swap(self, v):
-        r"""swap(vector_string_t self, vector_string_t v)"""
-        return _libBornAgainSample.vector_string_t_swap(self, v)
+        r"""swap(vector_string_T self, vector_string_T v)"""
+        return _libBornAgainSample.vector_string_T_swap(self, v)
 
     def begin(self):
-        r"""begin(vector_string_t self) -> std::vector< std::string >::iterator"""
-        return _libBornAgainSample.vector_string_t_begin(self)
+        r"""begin(vector_string_T self) -> std::vector< std::string >::iterator"""
+        return _libBornAgainSample.vector_string_T_begin(self)
 
     def end(self):
-        r"""end(vector_string_t self) -> std::vector< std::string >::iterator"""
-        return _libBornAgainSample.vector_string_t_end(self)
+        r"""end(vector_string_T self) -> std::vector< std::string >::iterator"""
+        return _libBornAgainSample.vector_string_T_end(self)
 
     def rbegin(self):
-        r"""rbegin(vector_string_t self) -> std::vector< std::string >::reverse_iterator"""
-        return _libBornAgainSample.vector_string_t_rbegin(self)
+        r"""rbegin(vector_string_T self) -> std::vector< std::string >::reverse_iterator"""
+        return _libBornAgainSample.vector_string_T_rbegin(self)
 
     def rend(self):
-        r"""rend(vector_string_t self) -> std::vector< std::string >::reverse_iterator"""
-        return _libBornAgainSample.vector_string_t_rend(self)
+        r"""rend(vector_string_T self) -> std::vector< std::string >::reverse_iterator"""
+        return _libBornAgainSample.vector_string_T_rend(self)
 
     def clear(self):
-        r"""clear(vector_string_t self)"""
-        return _libBornAgainSample.vector_string_t_clear(self)
+        r"""clear(vector_string_T self)"""
+        return _libBornAgainSample.vector_string_T_clear(self)
 
     def get_allocator(self):
-        r"""get_allocator(vector_string_t self) -> std::vector< std::string >::allocator_type"""
-        return _libBornAgainSample.vector_string_t_get_allocator(self)
+        r"""get_allocator(vector_string_T self) -> std::vector< std::string >::allocator_type"""
+        return _libBornAgainSample.vector_string_T_get_allocator(self)
 
     def pop_back(self):
-        r"""pop_back(vector_string_t self)"""
-        return _libBornAgainSample.vector_string_t_pop_back(self)
+        r"""pop_back(vector_string_T self)"""
+        return _libBornAgainSample.vector_string_T_pop_back(self)
 
     def erase(self, *args):
         r"""
-        erase(vector_string_t self, std::vector< std::string >::iterator pos) -> std::vector< std::string >::iterator
-        erase(vector_string_t self, std::vector< std::string >::iterator first, std::vector< std::string >::iterator last) -> std::vector< std::string >::iterator
+        erase(vector_string_T self, std::vector< std::string >::iterator pos) -> std::vector< std::string >::iterator
+        erase(vector_string_T self, std::vector< std::string >::iterator first, std::vector< std::string >::iterator last) -> std::vector< std::string >::iterator
         """
-        return _libBornAgainSample.vector_string_t_erase(self, *args)
+        return _libBornAgainSample.vector_string_T_erase(self, *args)
 
     def __init__(self, *args):
         r"""
-        __init__(vector_string_t self) -> vector_string_t
-        __init__(vector_string_t self, vector_string_t other) -> vector_string_t
-        __init__(vector_string_t self, std::vector< std::string >::size_type size) -> vector_string_t
-        __init__(vector_string_t self, std::vector< std::string >::size_type size, std::vector< std::string >::value_type const & value) -> vector_string_t
+        __init__(vector_string_T self) -> vector_string_T
+        __init__(vector_string_T self, vector_string_T other) -> vector_string_T
+        __init__(vector_string_T self, std::vector< std::string >::size_type size) -> vector_string_T
+        __init__(vector_string_T self, std::vector< std::string >::size_type size, std::vector< std::string >::value_type const & value) -> vector_string_T
         """
-        _libBornAgainSample.vector_string_t_swiginit(self, _libBornAgainSample.new_vector_string_t(*args))
+        _libBornAgainSample.vector_string_T_swiginit(self, _libBornAgainSample.new_vector_string_T(*args))
 
     def push_back(self, x):
-        r"""push_back(vector_string_t self, std::vector< std::string >::value_type const & x)"""
-        return _libBornAgainSample.vector_string_t_push_back(self, x)
+        r"""push_back(vector_string_T self, std::vector< std::string >::value_type const & x)"""
+        return _libBornAgainSample.vector_string_T_push_back(self, x)
 
     def front(self):
-        r"""front(vector_string_t self) -> std::vector< std::string >::value_type const &"""
-        return _libBornAgainSample.vector_string_t_front(self)
+        r"""front(vector_string_T self) -> std::vector< std::string >::value_type const &"""
+        return _libBornAgainSample.vector_string_T_front(self)
 
     def back(self):
-        r"""back(vector_string_t self) -> std::vector< std::string >::value_type const &"""
-        return _libBornAgainSample.vector_string_t_back(self)
+        r"""back(vector_string_T self) -> std::vector< std::string >::value_type const &"""
+        return _libBornAgainSample.vector_string_T_back(self)
 
     def assign(self, n, x):
-        r"""assign(vector_string_t self, std::vector< std::string >::size_type n, std::vector< std::string >::value_type const & x)"""
-        return _libBornAgainSample.vector_string_t_assign(self, n, x)
+        r"""assign(vector_string_T self, std::vector< std::string >::size_type n, std::vector< std::string >::value_type const & x)"""
+        return _libBornAgainSample.vector_string_T_assign(self, n, x)
 
     def resize(self, *args):
         r"""
-        resize(vector_string_t self, std::vector< std::string >::size_type new_size)
-        resize(vector_string_t self, std::vector< std::string >::size_type new_size, std::vector< std::string >::value_type const & x)
+        resize(vector_string_T self, std::vector< std::string >::size_type new_size)
+        resize(vector_string_T self, std::vector< std::string >::size_type new_size, std::vector< std::string >::value_type const & x)
         """
-        return _libBornAgainSample.vector_string_t_resize(self, *args)
+        return _libBornAgainSample.vector_string_T_resize(self, *args)
 
     def insert(self, *args):
         r"""
-        insert(vector_string_t self, std::vector< std::string >::iterator pos, std::vector< std::string >::value_type const & x) -> std::vector< std::string >::iterator
-        insert(vector_string_t self, std::vector< std::string >::iterator pos, std::vector< std::string >::size_type n, std::vector< std::string >::value_type const & x)
+        insert(vector_string_T self, std::vector< std::string >::iterator pos, std::vector< std::string >::value_type const & x) -> std::vector< std::string >::iterator
+        insert(vector_string_T self, std::vector< std::string >::iterator pos, std::vector< std::string >::size_type n, std::vector< std::string >::value_type const & x)
         """
-        return _libBornAgainSample.vector_string_t_insert(self, *args)
+        return _libBornAgainSample.vector_string_T_insert(self, *args)
 
     def reserve(self, n):
-        r"""reserve(vector_string_t self, std::vector< std::string >::size_type n)"""
-        return _libBornAgainSample.vector_string_t_reserve(self, n)
+        r"""reserve(vector_string_T self, std::vector< std::string >::size_type n)"""
+        return _libBornAgainSample.vector_string_T_reserve(self, n)
 
     def capacity(self):
-        r"""capacity(vector_string_t self) -> std::vector< std::string >::size_type"""
-        return _libBornAgainSample.vector_string_t_capacity(self)
-    __swig_destroy__ = _libBornAgainSample.delete_vector_string_t
+        r"""capacity(vector_string_T self) -> std::vector< std::string >::size_type"""
+        return _libBornAgainSample.vector_string_T_capacity(self)
+    __swig_destroy__ = _libBornAgainSample.delete_vector_string_T
 
-# Register vector_string_t in _libBornAgainSample:
-_libBornAgainSample.vector_string_t_swigregister(vector_string_t)
-class map_string_double_t(object):
+# Register vector_string_T in _libBornAgainSample:
+_libBornAgainSample.vector_string_T_swigregister(vector_string_T)
+class map_string_double_T(object):
     r"""Proxy of C++ std::map< std::string,double > class."""
 
     thisown = property(lambda x: x.this.own(), lambda x, v: x.this.own(v), doc="The membership flag")
     __repr__ = _swig_repr
 
     def iterator(self):
-        r"""iterator(map_string_double_t self) -> SwigPyIterator"""
-        return _libBornAgainSample.map_string_double_t_iterator(self)
+        r"""iterator(map_string_double_T self) -> SwigPyIterator"""
+        return _libBornAgainSample.map_string_double_T_iterator(self)
     def __iter__(self):
         return self.iterator()
 
     def __nonzero__(self):
-        r"""__nonzero__(map_string_double_t self) -> bool"""
-        return _libBornAgainSample.map_string_double_t___nonzero__(self)
+        r"""__nonzero__(map_string_double_T self) -> bool"""
+        return _libBornAgainSample.map_string_double_T___nonzero__(self)
 
     def __bool__(self):
-        r"""__bool__(map_string_double_t self) -> bool"""
-        return _libBornAgainSample.map_string_double_t___bool__(self)
+        r"""__bool__(map_string_double_T self) -> bool"""
+        return _libBornAgainSample.map_string_double_T___bool__(self)
 
     def __len__(self):
-        r"""__len__(map_string_double_t self) -> std::map< std::string,double >::size_type"""
-        return _libBornAgainSample.map_string_double_t___len__(self)
+        r"""__len__(map_string_double_T self) -> std::map< std::string,double >::size_type"""
+        return _libBornAgainSample.map_string_double_T___len__(self)
     def __iter__(self):
         return self.key_iterator()
     def iterkeys(self):
@@ -1348,124 +1348,124 @@ class map_string_double_t(object):
         return self.iterator()
 
     def __getitem__(self, key):
-        r"""__getitem__(map_string_double_t self, std::map< std::string,double >::key_type const & key) -> std::map< std::string,double >::mapped_type const &"""
-        return _libBornAgainSample.map_string_double_t___getitem__(self, key)
+        r"""__getitem__(map_string_double_T self, std::map< std::string,double >::key_type const & key) -> std::map< std::string,double >::mapped_type const &"""
+        return _libBornAgainSample.map_string_double_T___getitem__(self, key)
 
     def __delitem__(self, key):
-        r"""__delitem__(map_string_double_t self, std::map< std::string,double >::key_type const & key)"""
-        return _libBornAgainSample.map_string_double_t___delitem__(self, key)
+        r"""__delitem__(map_string_double_T self, std::map< std::string,double >::key_type const & key)"""
+        return _libBornAgainSample.map_string_double_T___delitem__(self, key)
 
     def has_key(self, key):
-        r"""has_key(map_string_double_t self, std::map< std::string,double >::key_type const & key) -> bool"""
-        return _libBornAgainSample.map_string_double_t_has_key(self, key)
+        r"""has_key(map_string_double_T self, std::map< std::string,double >::key_type const & key) -> bool"""
+        return _libBornAgainSample.map_string_double_T_has_key(self, key)
 
     def keys(self):
-        r"""keys(map_string_double_t self) -> PyObject *"""
-        return _libBornAgainSample.map_string_double_t_keys(self)
+        r"""keys(map_string_double_T self) -> PyObject *"""
+        return _libBornAgainSample.map_string_double_T_keys(self)
 
     def values(self):
-        r"""values(map_string_double_t self) -> PyObject *"""
-        return _libBornAgainSample.map_string_double_t_values(self)
+        r"""values(map_string_double_T self) -> PyObject *"""
+        return _libBornAgainSample.map_string_double_T_values(self)
 
     def items(self):
-        r"""items(map_string_double_t self) -> PyObject *"""
-        return _libBornAgainSample.map_string_double_t_items(self)
+        r"""items(map_string_double_T self) -> PyObject *"""
+        return _libBornAgainSample.map_string_double_T_items(self)
 
     def __contains__(self, key):
-        r"""__contains__(map_string_double_t self, std::map< std::string,double >::key_type const & key) -> bool"""
-        return _libBornAgainSample.map_string_double_t___contains__(self, key)
+        r"""__contains__(map_string_double_T self, std::map< std::string,double >::key_type const & key) -> bool"""
+        return _libBornAgainSample.map_string_double_T___contains__(self, key)
 
     def key_iterator(self):
-        r"""key_iterator(map_string_double_t self) -> SwigPyIterator"""
-        return _libBornAgainSample.map_string_double_t_key_iterator(self)
+        r"""key_iterator(map_string_double_T self) -> SwigPyIterator"""
+        return _libBornAgainSample.map_string_double_T_key_iterator(self)
 
     def value_iterator(self):
-        r"""value_iterator(map_string_double_t self) -> SwigPyIterator"""
-        return _libBornAgainSample.map_string_double_t_value_iterator(self)
+        r"""value_iterator(map_string_double_T self) -> SwigPyIterator"""
+        return _libBornAgainSample.map_string_double_T_value_iterator(self)
 
     def __setitem__(self, *args):
         r"""
-        __setitem__(map_string_double_t self, std::map< std::string,double >::key_type const & key)
-        __setitem__(map_string_double_t self, std::map< std::string,double >::key_type const & key, std::map< std::string,double >::mapped_type const & x)
+        __setitem__(map_string_double_T self, std::map< std::string,double >::key_type const & key)
+        __setitem__(map_string_double_T self, std::map< std::string,double >::key_type const & key, std::map< std::string,double >::mapped_type const & x)
         """
-        return _libBornAgainSample.map_string_double_t___setitem__(self, *args)
+        return _libBornAgainSample.map_string_double_T___setitem__(self, *args)
 
     def asdict(self):
-        r"""asdict(map_string_double_t self) -> PyObject *"""
-        return _libBornAgainSample.map_string_double_t_asdict(self)
+        r"""asdict(map_string_double_T self) -> PyObject *"""
+        return _libBornAgainSample.map_string_double_T_asdict(self)
 
     def __init__(self, *args):
         r"""
-        __init__(map_string_double_t self, std::less< std::string > const & other) -> map_string_double_t
-        __init__(map_string_double_t self) -> map_string_double_t
-        __init__(map_string_double_t self, map_string_double_t other) -> map_string_double_t
+        __init__(map_string_double_T self, std::less< std::string > const & other) -> map_string_double_T
+        __init__(map_string_double_T self) -> map_string_double_T
+        __init__(map_string_double_T self, map_string_double_T other) -> map_string_double_T
         """
-        _libBornAgainSample.map_string_double_t_swiginit(self, _libBornAgainSample.new_map_string_double_t(*args))
+        _libBornAgainSample.map_string_double_T_swiginit(self, _libBornAgainSample.new_map_string_double_T(*args))
 
     def empty(self):
-        r"""empty(map_string_double_t self) -> bool"""
-        return _libBornAgainSample.map_string_double_t_empty(self)
+        r"""empty(map_string_double_T self) -> bool"""
+        return _libBornAgainSample.map_string_double_T_empty(self)
 
     def size(self):
-        r"""size(map_string_double_t self) -> std::map< std::string,double >::size_type"""
-        return _libBornAgainSample.map_string_double_t_size(self)
+        r"""size(map_string_double_T self) -> std::map< std::string,double >::size_type"""
+        return _libBornAgainSample.map_string_double_T_size(self)
 
     def swap(self, v):
-        r"""swap(map_string_double_t self, map_string_double_t v)"""
-        return _libBornAgainSample.map_string_double_t_swap(self, v)
+        r"""swap(map_string_double_T self, map_string_double_T v)"""
+        return _libBornAgainSample.map_string_double_T_swap(self, v)
 
     def begin(self):
-        r"""begin(map_string_double_t self) -> std::map< std::string,double >::iterator"""
-        return _libBornAgainSample.map_string_double_t_begin(self)
+        r"""begin(map_string_double_T self) -> std::map< std::string,double >::iterator"""
+        return _libBornAgainSample.map_string_double_T_begin(self)
 
     def end(self):
-        r"""end(map_string_double_t self) -> std::map< std::string,double >::iterator"""
-        return _libBornAgainSample.map_string_double_t_end(self)
+        r"""end(map_string_double_T self) -> std::map< std::string,double >::iterator"""
+        return _libBornAgainSample.map_string_double_T_end(self)
 
     def rbegin(self):
-        r"""rbegin(map_string_double_t self) -> std::map< std::string,double >::reverse_iterator"""
-        return _libBornAgainSample.map_string_double_t_rbegin(self)
+        r"""rbegin(map_string_double_T self) -> std::map< std::string,double >::reverse_iterator"""
+        return _libBornAgainSample.map_string_double_T_rbegin(self)
 
     def rend(self):
-        r"""rend(map_string_double_t self) -> std::map< std::string,double >::reverse_iterator"""
-        return _libBornAgainSample.map_string_double_t_rend(self)
+        r"""rend(map_string_double_T self) -> std::map< std::string,double >::reverse_iterator"""
+        return _libBornAgainSample.map_string_double_T_rend(self)
 
     def clear(self):
-        r"""clear(map_string_double_t self)"""
-        return _libBornAgainSample.map_string_double_t_clear(self)
+        r"""clear(map_string_double_T self)"""
+        return _libBornAgainSample.map_string_double_T_clear(self)
 
     def get_allocator(self):
-        r"""get_allocator(map_string_double_t self) -> std::map< std::string,double >::allocator_type"""
-        return _libBornAgainSample.map_string_double_t_get_allocator(self)
+        r"""get_allocator(map_string_double_T self) -> std::map< std::string,double >::allocator_type"""
+        return _libBornAgainSample.map_string_double_T_get_allocator(self)
 
     def count(self, x):
-        r"""count(map_string_double_t self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::size_type"""
-        return _libBornAgainSample.map_string_double_t_count(self, x)
+        r"""count(map_string_double_T self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::size_type"""
+        return _libBornAgainSample.map_string_double_T_count(self, x)
 
     def erase(self, *args):
         r"""
-        erase(map_string_double_t self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::size_type
-        erase(map_string_double_t self, std::map< std::string,double >::iterator position)
-        erase(map_string_double_t self, std::map< std::string,double >::iterator first, std::map< std::string,double >::iterator last)
+        erase(map_string_double_T self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::size_type
+        erase(map_string_double_T self, std::map< std::string,double >::iterator position)
+        erase(map_string_double_T self, std::map< std::string,double >::iterator first, std::map< std::string,double >::iterator last)
         """
-        return _libBornAgainSample.map_string_double_t_erase(self, *args)
+        return _libBornAgainSample.map_string_double_T_erase(self, *args)
 
     def find(self, x):
-        r"""find(map_string_double_t self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"""
-        return _libBornAgainSample.map_string_double_t_find(self, x)
+        r"""find(map_string_double_T self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"""
+        return _libBornAgainSample.map_string_double_T_find(self, x)
 
     def lower_bound(self, x):
-        r"""lower_bound(map_string_double_t self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"""
-        return _libBornAgainSample.map_string_double_t_lower_bound(self, x)
+        r"""lower_bound(map_string_double_T self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"""
+        return _libBornAgainSample.map_string_double_T_lower_bound(self, x)
 
     def upper_bound(self, x):
-        r"""upper_bound(map_string_double_t self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"""
-        return _libBornAgainSample.map_string_double_t_upper_bound(self, x)
-    __swig_destroy__ = _libBornAgainSample.delete_map_string_double_t
+        r"""upper_bound(map_string_double_T self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"""
+        return _libBornAgainSample.map_string_double_T_upper_bound(self, x)
+    __swig_destroy__ = _libBornAgainSample.delete_map_string_double_T
 
-# Register map_string_double_t in _libBornAgainSample:
-_libBornAgainSample.map_string_double_t_swigregister(map_string_double_t)
-class pvacuum_double_t(object):
+# Register map_string_double_T in _libBornAgainSample:
+_libBornAgainSample.map_string_double_T_swigregister(map_string_double_T)
+class pvacuum_double_T(object):
     r"""Proxy of C++ std::pair< double,double > class."""
 
     thisown = property(lambda x: x.this.own(), lambda x, v: x.this.own(v), doc="The membership flag")
@@ -1473,13 +1473,13 @@ class pvacuum_double_t(object):
 
     def __init__(self, *args):
         r"""
-        __init__(pvacuum_double_t self) -> pvacuum_double_t
-        __init__(pvacuum_double_t self, double first, double second) -> pvacuum_double_t
-        __init__(pvacuum_double_t self, pvacuum_double_t other) -> pvacuum_double_t
+        __init__(pvacuum_double_T self) -> pvacuum_double_T
+        __init__(pvacuum_double_T self, double first, double second) -> pvacuum_double_T
+        __init__(pvacuum_double_T self, pvacuum_double_T other) -> pvacuum_double_T
         """
-        _libBornAgainSample.pvacuum_double_t_swiginit(self, _libBornAgainSample.new_pvacuum_double_t(*args))
-    first = property(_libBornAgainSample.pvacuum_double_t_first_get, _libBornAgainSample.pvacuum_double_t_first_set, doc=r"""first : double""")
-    second = property(_libBornAgainSample.pvacuum_double_t_second_get, _libBornAgainSample.pvacuum_double_t_second_set, doc=r"""second : double""")
+        _libBornAgainSample.pvacuum_double_T_swiginit(self, _libBornAgainSample.new_pvacuum_double_T(*args))
+    first = property(_libBornAgainSample.pvacuum_double_T_first_get, _libBornAgainSample.pvacuum_double_T_first_set, doc=r"""first : double""")
+    second = property(_libBornAgainSample.pvacuum_double_T_second_get, _libBornAgainSample.pvacuum_double_T_second_set, doc=r"""second : double""")
     def __len__(self):
         return 2
     def __repr__(self):
@@ -1494,176 +1494,176 @@ class pvacuum_double_t(object):
             self.first = val
         else:
             self.second = val
-    __swig_destroy__ = _libBornAgainSample.delete_pvacuum_double_t
+    __swig_destroy__ = _libBornAgainSample.delete_pvacuum_double_T
 
-# Register pvacuum_double_t in _libBornAgainSample:
-_libBornAgainSample.pvacuum_double_t_swigregister(pvacuum_double_t)
-class vector_pvacuum_double_t(object):
+# Register pvacuum_double_T in _libBornAgainSample:
+_libBornAgainSample.pvacuum_double_T_swigregister(pvacuum_double_T)
+class vector_pvacuum_double_T(object):
     r"""Proxy of C++ std::vector< std::pair< double,double > > class."""
 
     thisown = property(lambda x: x.this.own(), lambda x, v: x.this.own(v), doc="The membership flag")
     __repr__ = _swig_repr
 
     def iterator(self):
-        r"""iterator(vector_pvacuum_double_t self) -> SwigPyIterator"""
-        return _libBornAgainSample.vector_pvacuum_double_t_iterator(self)
+        r"""iterator(vector_pvacuum_double_T self) -> SwigPyIterator"""
+        return _libBornAgainSample.vector_pvacuum_double_T_iterator(self)
     def __iter__(self):
         return self.iterator()
 
     def __nonzero__(self):
-        r"""__nonzero__(vector_pvacuum_double_t self) -> bool"""
-        return _libBornAgainSample.vector_pvacuum_double_t___nonzero__(self)
+        r"""__nonzero__(vector_pvacuum_double_T self) -> bool"""
+        return _libBornAgainSample.vector_pvacuum_double_T___nonzero__(self)
 
     def __bool__(self):
-        r"""__bool__(vector_pvacuum_double_t self) -> bool"""
-        return _libBornAgainSample.vector_pvacuum_double_t___bool__(self)
+        r"""__bool__(vector_pvacuum_double_T self) -> bool"""
+        return _libBornAgainSample.vector_pvacuum_double_T___bool__(self)
 
     def __len__(self):
-        r"""__len__(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::size_type"""
-        return _libBornAgainSample.vector_pvacuum_double_t___len__(self)
+        r"""__len__(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::size_type"""
+        return _libBornAgainSample.vector_pvacuum_double_T___len__(self)
 
     def __getslice__(self, i, j):
-        r"""__getslice__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j) -> vector_pvacuum_double_t"""
-        return _libBornAgainSample.vector_pvacuum_double_t___getslice__(self, i, j)
+        r"""__getslice__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j) -> vector_pvacuum_double_T"""
+        return _libBornAgainSample.vector_pvacuum_double_T___getslice__(self, i, j)
 
     def __setslice__(self, *args):
         r"""
-        __setslice__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j)
-        __setslice__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j, vector_pvacuum_double_t v)
+        __setslice__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j)
+        __setslice__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j, vector_pvacuum_double_T v)
         """
-        return _libBornAgainSample.vector_pvacuum_double_t___setslice__(self, *args)
+        return _libBornAgainSample.vector_pvacuum_double_T___setslice__(self, *args)
 
     def __delslice__(self, i, j):
-        r"""__delslice__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j)"""
-        return _libBornAgainSample.vector_pvacuum_double_t___delslice__(self, i, j)
+        r"""__delslice__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j)"""
+        return _libBornAgainSample.vector_pvacuum_double_T___delslice__(self, i, j)
 
     def __delitem__(self, *args):
         r"""
-        __delitem__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i)
-        __delitem__(vector_pvacuum_double_t self, SWIGPY_SLICEOBJECT * slice)
+        __delitem__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i)
+        __delitem__(vector_pvacuum_double_T self, SWIGPY_SLICEOBJECT * slice)
         """
-        return _libBornAgainSample.vector_pvacuum_double_t___delitem__(self, *args)
+        return _libBornAgainSample.vector_pvacuum_double_T___delitem__(self, *args)
 
     def __getitem__(self, *args):
         r"""
-        __getitem__(vector_pvacuum_double_t self, SWIGPY_SLICEOBJECT * slice) -> vector_pvacuum_double_t
-        __getitem__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i) -> pvacuum_double_t
+        __getitem__(vector_pvacuum_double_T self, SWIGPY_SLICEOBJECT * slice) -> vector_pvacuum_double_T
+        __getitem__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i) -> pvacuum_double_T
         """
-        return _libBornAgainSample.vector_pvacuum_double_t___getitem__(self, *args)
+        return _libBornAgainSample.vector_pvacuum_double_T___getitem__(self, *args)
 
     def __setitem__(self, *args):
         r"""
-        __setitem__(vector_pvacuum_double_t self, SWIGPY_SLICEOBJECT * slice, vector_pvacuum_double_t v)
-        __setitem__(vector_pvacuum_double_t self, SWIGPY_SLICEOBJECT * slice)
-        __setitem__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i, pvacuum_double_t x)
+        __setitem__(vector_pvacuum_double_T self, SWIGPY_SLICEOBJECT * slice, vector_pvacuum_double_T v)
+        __setitem__(vector_pvacuum_double_T self, SWIGPY_SLICEOBJECT * slice)
+        __setitem__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i, pvacuum_double_T x)
         """
-        return _libBornAgainSample.vector_pvacuum_double_t___setitem__(self, *args)
+        return _libBornAgainSample.vector_pvacuum_double_T___setitem__(self, *args)
 
     def pop(self):
-        r"""pop(vector_pvacuum_double_t self) -> pvacuum_double_t"""
-        return _libBornAgainSample.vector_pvacuum_double_t_pop(self)
+        r"""pop(vector_pvacuum_double_T self) -> pvacuum_double_T"""
+        return _libBornAgainSample.vector_pvacuum_double_T_pop(self)
 
     def append(self, x):
-        r"""append(vector_pvacuum_double_t self, pvacuum_double_t x)"""
-        return _libBornAgainSample.vector_pvacuum_double_t_append(self, x)
+        r"""append(vector_pvacuum_double_T self, pvacuum_double_T x)"""
+        return _libBornAgainSample.vector_pvacuum_double_T_append(self, x)
 
     def empty(self):
-        r"""empty(vector_pvacuum_double_t self) -> bool"""
-        return _libBornAgainSample.vector_pvacuum_double_t_empty(self)
+        r"""empty(vector_pvacuum_double_T self) -> bool"""
+        return _libBornAgainSample.vector_pvacuum_double_T_empty(self)
 
     def size(self):
-        r"""size(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::size_type"""
-        return _libBornAgainSample.vector_pvacuum_double_t_size(self)
+        r"""size(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::size_type"""
+        return _libBornAgainSample.vector_pvacuum_double_T_size(self)
 
     def swap(self, v):
-        r"""swap(vector_pvacuum_double_t self, vector_pvacuum_double_t v)"""
-        return _libBornAgainSample.vector_pvacuum_double_t_swap(self, v)
+        r"""swap(vector_pvacuum_double_T self, vector_pvacuum_double_T v)"""
+        return _libBornAgainSample.vector_pvacuum_double_T_swap(self, v)
 
     def begin(self):
-        r"""begin(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::iterator"""
-        return _libBornAgainSample.vector_pvacuum_double_t_begin(self)
+        r"""begin(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::iterator"""
+        return _libBornAgainSample.vector_pvacuum_double_T_begin(self)
 
     def end(self):
-        r"""end(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::iterator"""
-        return _libBornAgainSample.vector_pvacuum_double_t_end(self)
+        r"""end(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::iterator"""
+        return _libBornAgainSample.vector_pvacuum_double_T_end(self)
 
     def rbegin(self):
-        r"""rbegin(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::reverse_iterator"""
-        return _libBornAgainSample.vector_pvacuum_double_t_rbegin(self)
+        r"""rbegin(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::reverse_iterator"""
+        return _libBornAgainSample.vector_pvacuum_double_T_rbegin(self)
 
     def rend(self):
-        r"""rend(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::reverse_iterator"""
-        return _libBornAgainSample.vector_pvacuum_double_t_rend(self)
+        r"""rend(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::reverse_iterator"""
+        return _libBornAgainSample.vector_pvacuum_double_T_rend(self)
 
     def clear(self):
-        r"""clear(vector_pvacuum_double_t self)"""
-        return _libBornAgainSample.vector_pvacuum_double_t_clear(self)
+        r"""clear(vector_pvacuum_double_T self)"""
+        return _libBornAgainSample.vector_pvacuum_double_T_clear(self)
 
     def get_allocator(self):
-        r"""get_allocator(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::allocator_type"""
-        return _libBornAgainSample.vector_pvacuum_double_t_get_allocator(self)
+        r"""get_allocator(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::allocator_type"""
+        return _libBornAgainSample.vector_pvacuum_double_T_get_allocator(self)
 
     def pop_back(self):
-        r"""pop_back(vector_pvacuum_double_t self)"""
-        return _libBornAgainSample.vector_pvacuum_double_t_pop_back(self)
+        r"""pop_back(vector_pvacuum_double_T self)"""
+        return _libBornAgainSample.vector_pvacuum_double_T_pop_back(self)
 
     def erase(self, *args):
         r"""
-        erase(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::iterator pos) -> std::vector< std::pair< double,double > >::iterator
-        erase(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::iterator first, std::vector< std::pair< double,double > >::iterator last) -> std::vector< std::pair< double,double > >::iterator
+        erase(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::iterator pos) -> std::vector< std::pair< double,double > >::iterator
+        erase(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::iterator first, std::vector< std::pair< double,double > >::iterator last) -> std::vector< std::pair< double,double > >::iterator
         """
-        return _libBornAgainSample.vector_pvacuum_double_t_erase(self, *args)
+        return _libBornAgainSample.vector_pvacuum_double_T_erase(self, *args)
 
     def __init__(self, *args):
         r"""
-        __init__(vector_pvacuum_double_t self) -> vector_pvacuum_double_t
-        __init__(vector_pvacuum_double_t self, vector_pvacuum_double_t other) -> vector_pvacuum_double_t
-        __init__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::size_type size) -> vector_pvacuum_double_t
-        __init__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::size_type size, pvacuum_double_t value) -> vector_pvacuum_double_t
+        __init__(vector_pvacuum_double_T self) -> vector_pvacuum_double_T
+        __init__(vector_pvacuum_double_T self, vector_pvacuum_double_T other) -> vector_pvacuum_double_T
+        __init__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::size_type size) -> vector_pvacuum_double_T
+        __init__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::size_type size, pvacuum_double_T value) -> vector_pvacuum_double_T
         """
-        _libBornAgainSample.vector_pvacuum_double_t_swiginit(self, _libBornAgainSample.new_vector_pvacuum_double_t(*args))
+        _libBornAgainSample.vector_pvacuum_double_T_swiginit(self, _libBornAgainSample.new_vector_pvacuum_double_T(*args))
 
     def push_back(self, x):
-        r"""push_back(vector_pvacuum_double_t self, pvacuum_double_t x)"""
-        return _libBornAgainSample.vector_pvacuum_double_t_push_back(self, x)
+        r"""push_back(vector_pvacuum_double_T self, pvacuum_double_T x)"""
+        return _libBornAgainSample.vector_pvacuum_double_T_push_back(self, x)
 
     def front(self):
-        r"""front(vector_pvacuum_double_t self) -> pvacuum_double_t"""
-        return _libBornAgainSample.vector_pvacuum_double_t_front(self)
+        r"""front(vector_pvacuum_double_T self) -> pvacuum_double_T"""
+        return _libBornAgainSample.vector_pvacuum_double_T_front(self)
 
     def back(self):
-        r"""back(vector_pvacuum_double_t self) -> pvacuum_double_t"""
-        return _libBornAgainSample.vector_pvacuum_double_t_back(self)
+        r"""back(vector_pvacuum_double_T self) -> pvacuum_double_T"""
+        return _libBornAgainSample.vector_pvacuum_double_T_back(self)
 
     def assign(self, n, x):
-        r"""assign(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::size_type n, pvacuum_double_t x)"""
-        return _libBornAgainSample.vector_pvacuum_double_t_assign(self, n, x)
+        r"""assign(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::size_type n, pvacuum_double_T x)"""
+        return _libBornAgainSample.vector_pvacuum_double_T_assign(self, n, x)
 
     def resize(self, *args):
         r"""
-        resize(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::size_type new_size)
-        resize(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::size_type new_size, pvacuum_double_t x)
+        resize(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::size_type new_size)
+        resize(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::size_type new_size, pvacuum_double_T x)
         """
-        return _libBornAgainSample.vector_pvacuum_double_t_resize(self, *args)
+        return _libBornAgainSample.vector_pvacuum_double_T_resize(self, *args)
 
     def insert(self, *args):
         r"""
-        insert(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::iterator pos, pvacuum_double_t x) -> std::vector< std::pair< double,double > >::iterator
-        insert(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::iterator pos, std::vector< std::pair< double,double > >::size_type n, pvacuum_double_t x)
+        insert(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::iterator pos, pvacuum_double_T x) -> std::vector< std::pair< double,double > >::iterator
+        insert(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::iterator pos, std::vector< std::pair< double,double > >::size_type n, pvacuum_double_T x)
         """
-        return _libBornAgainSample.vector_pvacuum_double_t_insert(self, *args)
+        return _libBornAgainSample.vector_pvacuum_double_T_insert(self, *args)
 
     def reserve(self, n):
-        r"""reserve(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::size_type n)"""
-        return _libBornAgainSample.vector_pvacuum_double_t_reserve(self, n)
+        r"""reserve(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::size_type n)"""
+        return _libBornAgainSample.vector_pvacuum_double_T_reserve(self, n)
 
     def capacity(self):
-        r"""capacity(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::size_type"""
-        return _libBornAgainSample.vector_pvacuum_double_t_capacity(self)
-    __swig_destroy__ = _libBornAgainSample.delete_vector_pvacuum_double_t
+        r"""capacity(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::size_type"""
+        return _libBornAgainSample.vector_pvacuum_double_T_capacity(self)
+    __swig_destroy__ = _libBornAgainSample.delete_vector_pvacuum_double_T
 
-# Register vector_pvacuum_double_t in _libBornAgainSample:
-_libBornAgainSample.vector_pvacuum_double_t_swigregister(vector_pvacuum_double_t)
+# Register vector_pvacuum_double_T in _libBornAgainSample:
+_libBornAgainSample.vector_pvacuum_double_T_swigregister(vector_pvacuum_double_T)
 import libBornAgainBase
 class R3(object):
     r"""Proxy of C++ Vec3< double > class."""
@@ -2444,7 +2444,7 @@ class ISampleNode(libBornAgainBase.ICloneable, libBornAgainParam.INode):
     def __init__(self, *args):
         r"""
         __init__(ISampleNode self) -> ISampleNode
-        __init__(ISampleNode self, vdouble1d_t PValues) -> ISampleNode
+        __init__(ISampleNode self, vdouble1d_T PValues) -> ISampleNode
         """
         if self.__class__ == ISampleNode:
             _self = None
@@ -2472,7 +2472,7 @@ class IFormfactor(ISampleNode):
     def __init__(self, *args):
         r"""
         __init__(IFormfactor self) -> IFormfactor
-        __init__(IFormfactor self, vdouble1d_t PValues) -> IFormfactor
+        __init__(IFormfactor self, vdouble1d_T PValues) -> IFormfactor
         """
         if self.__class__ == IFormfactor:
             _self = None
@@ -2621,7 +2621,7 @@ class RotationX(IRotation):
 
     def __init__(self, *args):
         r"""
-        __init__(RotationX self, vdouble1d_t P) -> RotationX
+        __init__(RotationX self, vdouble1d_T P) -> RotationX
         __init__(RotationX self, double angle) -> RotationX
         """
         _libBornAgainSample.RotationX_swiginit(self, _libBornAgainSample.new_RotationX(*args))
@@ -2661,7 +2661,7 @@ class RotationY(IRotation):
 
     def __init__(self, *args):
         r"""
-        __init__(RotationY self, vdouble1d_t P) -> RotationY
+        __init__(RotationY self, vdouble1d_T P) -> RotationY
         __init__(RotationY self, double angle) -> RotationY
         """
         _libBornAgainSample.RotationY_swiginit(self, _libBornAgainSample.new_RotationY(*args))
@@ -2701,7 +2701,7 @@ class RotationZ(IRotation):
 
     def __init__(self, *args):
         r"""
-        __init__(RotationZ self, vdouble1d_t P) -> RotationZ
+        __init__(RotationZ self, vdouble1d_T P) -> RotationZ
         __init__(RotationZ self, double angle) -> RotationZ
         """
         _libBornAgainSample.RotationZ_swiginit(self, _libBornAgainSample.new_RotationZ(*args))
@@ -2741,7 +2741,7 @@ class RotationEuler(IRotation):
 
     def __init__(self, *args):
         r"""
-        __init__(RotationEuler self, vdouble1d_t P) -> RotationEuler
+        __init__(RotationEuler self, vdouble1d_T P) -> RotationEuler
         __init__(RotationEuler self, double alpha, double beta, double gamma) -> RotationEuler
         """
         _libBornAgainSample.RotationEuler_swiginit(self, _libBornAgainSample.new_RotationEuler(*args))
@@ -3016,7 +3016,7 @@ class Profile1DCauchy(IProfile1D):
 
     def __init__(self, *args):
         r"""
-        __init__(Profile1DCauchy self, vdouble1d_t P) -> Profile1DCauchy
+        __init__(Profile1DCauchy self, vdouble1d_T P) -> Profile1DCauchy
         __init__(Profile1DCauchy self, double omega) -> Profile1DCauchy
         """
         _libBornAgainSample.Profile1DCauchy_swiginit(self, _libBornAgainSample.new_Profile1DCauchy(*args))
@@ -3052,7 +3052,7 @@ class Profile1DGauss(IProfile1D):
 
     def __init__(self, *args):
         r"""
-        __init__(Profile1DGauss self, vdouble1d_t P) -> Profile1DGauss
+        __init__(Profile1DGauss self, vdouble1d_T P) -> Profile1DGauss
         __init__(Profile1DGauss self, double omega) -> Profile1DGauss
         """
         _libBornAgainSample.Profile1DGauss_swiginit(self, _libBornAgainSample.new_Profile1DGauss(*args))
@@ -3088,7 +3088,7 @@ class Profile1DGate(IProfile1D):
 
     def __init__(self, *args):
         r"""
-        __init__(Profile1DGate self, vdouble1d_t P) -> Profile1DGate
+        __init__(Profile1DGate self, vdouble1d_T P) -> Profile1DGate
         __init__(Profile1DGate self, double omega) -> Profile1DGate
         """
         _libBornAgainSample.Profile1DGate_swiginit(self, _libBornAgainSample.new_Profile1DGate(*args))
@@ -3124,7 +3124,7 @@ class Profile1DTriangle(IProfile1D):
 
     def __init__(self, *args):
         r"""
-        __init__(Profile1DTriangle self, vdouble1d_t P) -> Profile1DTriangle
+        __init__(Profile1DTriangle self, vdouble1d_T P) -> Profile1DTriangle
         __init__(Profile1DTriangle self, double omega) -> Profile1DTriangle
         """
         _libBornAgainSample.Profile1DTriangle_swiginit(self, _libBornAgainSample.new_Profile1DTriangle(*args))
@@ -3160,7 +3160,7 @@ class Profile1DCosine(IProfile1D):
 
     def __init__(self, *args):
         r"""
-        __init__(Profile1DCosine self, vdouble1d_t P) -> Profile1DCosine
+        __init__(Profile1DCosine self, vdouble1d_T P) -> Profile1DCosine
         __init__(Profile1DCosine self, double omega) -> Profile1DCosine
         """
         _libBornAgainSample.Profile1DCosine_swiginit(self, _libBornAgainSample.new_Profile1DCosine(*args))
@@ -3196,7 +3196,7 @@ class Profile1DVoigt(IProfile1D):
 
     def __init__(self, *args):
         r"""
-        __init__(Profile1DVoigt self, vdouble1d_t P) -> Profile1DVoigt
+        __init__(Profile1DVoigt self, vdouble1d_T P) -> Profile1DVoigt
         __init__(Profile1DVoigt self, double omega, double eta) -> Profile1DVoigt
         """
         _libBornAgainSample.Profile1DVoigt_swiginit(self, _libBornAgainSample.new_Profile1DVoigt(*args))
@@ -3300,7 +3300,7 @@ class Profile2DCauchy(IProfile2D):
 
     def __init__(self, *args):
         r"""
-        __init__(Profile2DCauchy self, vdouble1d_t P) -> Profile2DCauchy
+        __init__(Profile2DCauchy self, vdouble1d_T P) -> Profile2DCauchy
         __init__(Profile2DCauchy self, double omega_x, double omega_y, double gamma) -> Profile2DCauchy
         """
         _libBornAgainSample.Profile2DCauchy_swiginit(self, _libBornAgainSample.new_Profile2DCauchy(*args))
@@ -3332,7 +3332,7 @@ class Profile2DGauss(IProfile2D):
 
     def __init__(self, *args):
         r"""
-        __init__(Profile2DGauss self, vdouble1d_t P) -> Profile2DGauss
+        __init__(Profile2DGauss self, vdouble1d_T P) -> Profile2DGauss
         __init__(Profile2DGauss self, double omega_x, double omega_y, double gamma) -> Profile2DGauss
         """
         _libBornAgainSample.Profile2DGauss_swiginit(self, _libBornAgainSample.new_Profile2DGauss(*args))
@@ -3364,7 +3364,7 @@ class Profile2DGate(IProfile2D):
 
     def __init__(self, *args):
         r"""
-        __init__(Profile2DGate self, vdouble1d_t P) -> Profile2DGate
+        __init__(Profile2DGate self, vdouble1d_T P) -> Profile2DGate
         __init__(Profile2DGate self, double omega_x, double omega_y, double gamma) -> Profile2DGate
         """
         _libBornAgainSample.Profile2DGate_swiginit(self, _libBornAgainSample.new_Profile2DGate(*args))
@@ -3396,7 +3396,7 @@ class Profile2DCone(IProfile2D):
 
     def __init__(self, *args):
         r"""
-        __init__(Profile2DCone self, vdouble1d_t P) -> Profile2DCone
+        __init__(Profile2DCone self, vdouble1d_T P) -> Profile2DCone
         __init__(Profile2DCone self, double omega_x, double omega_y, double gamma) -> Profile2DCone
         """
         _libBornAgainSample.Profile2DCone_swiginit(self, _libBornAgainSample.new_Profile2DCone(*args))
@@ -3428,7 +3428,7 @@ class Profile2DVoigt(IProfile2D):
 
     def __init__(self, *args):
         r"""
-        __init__(Profile2DVoigt self, vdouble1d_t P) -> Profile2DVoigt
+        __init__(Profile2DVoigt self, vdouble1d_T P) -> Profile2DVoigt
         __init__(Profile2DVoigt self, double omega_x, double omega_y, double gamma, double eta) -> Profile2DVoigt
         """
         _libBornAgainSample.Profile2DVoigt_swiginit(self, _libBornAgainSample.new_Profile2DVoigt(*args))
@@ -3844,7 +3844,7 @@ class Interference2DParacrystal(IInterference):
         return _libBornAgainSample.Interference2DParacrystal_setDampingLength(self, damping_length)
 
     def domainSizes(self):
-        r"""domainSizes(Interference2DParacrystal self) -> vdouble1d_t"""
+        r"""domainSizes(Interference2DParacrystal self) -> vdouble1d_T"""
         return _libBornAgainSample.Interference2DParacrystal_domainSizes(self)
 
     def setIntegrationOverXi(self, integrate_xi):
@@ -4552,7 +4552,7 @@ class Box(IFormfactorPrism):
     def __init__(self, *args):
         r"""
         __init__(Box self, double length, double width, double height) -> Box
-        __init__(Box self, vdouble1d_t P) -> Box
+        __init__(Box self, vdouble1d_T P) -> Box
         """
         _libBornAgainSample.Box_swiginit(self, _libBornAgainSample.new_Box(*args))
 
@@ -4596,7 +4596,7 @@ class Prism3(IFormfactorPrism):
     def __init__(self, *args):
         r"""
         __init__(Prism3 self, double base_edge, double height) -> Prism3
-        __init__(Prism3 self, vdouble1d_t P) -> Prism3
+        __init__(Prism3 self, vdouble1d_T P) -> Prism3
         """
         _libBornAgainSample.Prism3_swiginit(self, _libBornAgainSample.new_Prism3(*args))
 
@@ -4636,7 +4636,7 @@ class Prism6(IFormfactorPrism):
     def __init__(self, *args):
         r"""
         __init__(Prism6 self, double base_edge, double height) -> Prism6
-        __init__(Prism6 self, vdouble1d_t P) -> Prism6
+        __init__(Prism6 self, vdouble1d_T P) -> Prism6
         """
         _libBornAgainSample.Prism6_swiginit(self, _libBornAgainSample.new_Prism6(*args))
 
@@ -4676,7 +4676,7 @@ class PlatonicTetrahedron(IFormfactorPolyhedron):
     def __init__(self, *args):
         r"""
         __init__(PlatonicTetrahedron self, double edge) -> PlatonicTetrahedron
-        __init__(PlatonicTetrahedron self, vdouble1d_t P) -> PlatonicTetrahedron
+        __init__(PlatonicTetrahedron self, vdouble1d_T P) -> PlatonicTetrahedron
         """
         _libBornAgainSample.PlatonicTetrahedron_swiginit(self, _libBornAgainSample.new_PlatonicTetrahedron(*args))
 
@@ -4716,7 +4716,7 @@ class PlatonicOctahedron(IFormfactorPolyhedron):
     def __init__(self, *args):
         r"""
         __init__(PlatonicOctahedron self, double edge) -> PlatonicOctahedron
-        __init__(PlatonicOctahedron self, vdouble1d_t P) -> PlatonicOctahedron
+        __init__(PlatonicOctahedron self, vdouble1d_T P) -> PlatonicOctahedron
         """
         _libBornAgainSample.PlatonicOctahedron_swiginit(self, _libBornAgainSample.new_PlatonicOctahedron(*args))
 
@@ -4756,7 +4756,7 @@ class Dodecahedron(IFormfactorPolyhedron):
     def __init__(self, *args):
         r"""
         __init__(Dodecahedron self, double edge) -> Dodecahedron
-        __init__(Dodecahedron self, vdouble1d_t P) -> Dodecahedron
+        __init__(Dodecahedron self, vdouble1d_T P) -> Dodecahedron
         """
         _libBornAgainSample.Dodecahedron_swiginit(self, _libBornAgainSample.new_Dodecahedron(*args))
 
@@ -4792,7 +4792,7 @@ class Icosahedron(IFormfactorPolyhedron):
     def __init__(self, *args):
         r"""
         __init__(Icosahedron self, double edge) -> Icosahedron
-        __init__(Icosahedron self, vdouble1d_t P) -> Icosahedron
+        __init__(Icosahedron self, vdouble1d_T P) -> Icosahedron
         """
         _libBornAgainSample.Icosahedron_swiginit(self, _libBornAgainSample.new_Icosahedron(*args))
 
@@ -4828,7 +4828,7 @@ class Pyramid2(IFormfactorPolyhedron):
     def __init__(self, *args):
         r"""
         __init__(Pyramid2 self, double length, double width, double height, double alpha) -> Pyramid2
-        __init__(Pyramid2 self, vdouble1d_t P) -> Pyramid2
+        __init__(Pyramid2 self, vdouble1d_T P) -> Pyramid2
         """
         _libBornAgainSample.Pyramid2_swiginit(self, _libBornAgainSample.new_Pyramid2(*args))
 
@@ -4876,7 +4876,7 @@ class Pyramid3(IFormfactorPolyhedron):
     def __init__(self, *args):
         r"""
         __init__(Pyramid3 self, double base_edge, double height, double alpha) -> Pyramid3
-        __init__(Pyramid3 self, vdouble1d_t P) -> Pyramid3
+        __init__(Pyramid3 self, vdouble1d_T P) -> Pyramid3
         """
         _libBornAgainSample.Pyramid3_swiginit(self, _libBornAgainSample.new_Pyramid3(*args))
 
@@ -4920,7 +4920,7 @@ class Pyramid4(IFormfactorPolyhedron):
     def __init__(self, *args):
         r"""
         __init__(Pyramid4 self, double base_edge, double height, double alpha) -> Pyramid4
-        __init__(Pyramid4 self, vdouble1d_t P) -> Pyramid4
+        __init__(Pyramid4 self, vdouble1d_T P) -> Pyramid4
         """
         _libBornAgainSample.Pyramid4_swiginit(self, _libBornAgainSample.new_Pyramid4(*args))
 
@@ -4964,7 +4964,7 @@ class Pyramid6(IFormfactorPolyhedron):
     def __init__(self, *args):
         r"""
         __init__(Pyramid6 self, double base_edge, double height, double alpha) -> Pyramid6
-        __init__(Pyramid6 self, vdouble1d_t P) -> Pyramid6
+        __init__(Pyramid6 self, vdouble1d_T P) -> Pyramid6
         """
         _libBornAgainSample.Pyramid6_swiginit(self, _libBornAgainSample.new_Pyramid6(*args))
 
@@ -5008,7 +5008,7 @@ class Bipyramid4(IFormfactorPolyhedron):
     def __init__(self, *args):
         r"""
         __init__(Bipyramid4 self, double length, double base_height, double height_ratio, double alpha) -> Bipyramid4
-        __init__(Bipyramid4 self, vdouble1d_t P) -> Bipyramid4
+        __init__(Bipyramid4 self, vdouble1d_T P) -> Bipyramid4
         """
         _libBornAgainSample.Bipyramid4_swiginit(self, _libBornAgainSample.new_Bipyramid4(*args))
 
@@ -5060,7 +5060,7 @@ class CantellatedCube(IFormfactorPolyhedron):
     def __init__(self, *args):
         r"""
         __init__(CantellatedCube self, double length, double removed_length) -> CantellatedCube
-        __init__(CantellatedCube self, vdouble1d_t P) -> CantellatedCube
+        __init__(CantellatedCube self, vdouble1d_T P) -> CantellatedCube
         """
         _libBornAgainSample.CantellatedCube_swiginit(self, _libBornAgainSample.new_CantellatedCube(*args))
 
@@ -5100,7 +5100,7 @@ class TruncatedCube(IFormfactorPolyhedron):
     def __init__(self, *args):
         r"""
         __init__(TruncatedCube self, double length, double removed_length) -> TruncatedCube
-        __init__(TruncatedCube self, vdouble1d_t P) -> TruncatedCube
+        __init__(TruncatedCube self, vdouble1d_T P) -> TruncatedCube
         """
         _libBornAgainSample.TruncatedCube_swiginit(self, _libBornAgainSample.new_TruncatedCube(*args))
 
@@ -5140,7 +5140,7 @@ class Cone(IFormfactor):
     def __init__(self, *args):
         r"""
         __init__(Cone self, double radius, double height, double alpha) -> Cone
-        __init__(Cone self, vdouble1d_t P) -> Cone
+        __init__(Cone self, vdouble1d_T P) -> Cone
         """
         _libBornAgainSample.Cone_swiginit(self, _libBornAgainSample.new_Cone(*args))
 
@@ -5196,7 +5196,7 @@ class Cylinder(IFormfactor):
     def __init__(self, *args):
         r"""
         __init__(Cylinder self, double radius, double height) -> Cylinder
-        __init__(Cylinder self, vdouble1d_t P) -> Cylinder
+        __init__(Cylinder self, vdouble1d_T P) -> Cylinder
         """
         _libBornAgainSample.Cylinder_swiginit(self, _libBornAgainSample.new_Cylinder(*args))
 
@@ -5248,7 +5248,7 @@ class EllipsoidalCylinder(IFormfactor):
     def __init__(self, *args):
         r"""
         __init__(EllipsoidalCylinder self, double radius_x, double radius_y, double height) -> EllipsoidalCylinder
-        __init__(EllipsoidalCylinder self, vdouble1d_t P) -> EllipsoidalCylinder
+        __init__(EllipsoidalCylinder self, vdouble1d_T P) -> EllipsoidalCylinder
         """
         _libBornAgainSample.EllipsoidalCylinder_swiginit(self, _libBornAgainSample.new_EllipsoidalCylinder(*args))
 
@@ -5304,7 +5304,7 @@ class HemiEllipsoid(IFormfactor):
     def __init__(self, *args):
         r"""
         __init__(HemiEllipsoid self, double radius_x, double radius_y, double height) -> HemiEllipsoid
-        __init__(HemiEllipsoid self, vdouble1d_t P) -> HemiEllipsoid
+        __init__(HemiEllipsoid self, vdouble1d_T P) -> HemiEllipsoid
         """
         _libBornAgainSample.HemiEllipsoid_swiginit(self, _libBornAgainSample.new_HemiEllipsoid(*args))
     __swig_destroy__ = _libBornAgainSample.delete_HemiEllipsoid
@@ -5361,7 +5361,7 @@ class HorizontalCylinder(IFormfactor):
         r"""
         __init__(HorizontalCylinder self, double radius, double length, double slice_bottom, double slice_top) -> HorizontalCylinder
         __init__(HorizontalCylinder self, double radius, double length) -> HorizontalCylinder
-        __init__(HorizontalCylinder self, vdouble1d_t P) -> HorizontalCylinder
+        __init__(HorizontalCylinder self, vdouble1d_T P) -> HorizontalCylinder
         """
         _libBornAgainSample.HorizontalCylinder_swiginit(self, _libBornAgainSample.new_HorizontalCylinder(*args))
 
@@ -5425,7 +5425,7 @@ class Sphere(IFormfactor):
     def __init__(self, *args):
         r"""
         __init__(Sphere self, double radius, bool position_at_center=False) -> Sphere
-        __init__(Sphere self, vdouble1d_t P, bool position_at_center=False) -> Sphere
+        __init__(Sphere self, vdouble1d_T P, bool position_at_center=False) -> Sphere
         """
         _libBornAgainSample.Sphere_swiginit(self, _libBornAgainSample.new_Sphere(*args))
 
@@ -5481,7 +5481,7 @@ class Spheroid(IFormfactor):
     def __init__(self, *args):
         r"""
         __init__(Spheroid self, double radius, double height) -> Spheroid
-        __init__(Spheroid self, vdouble1d_t P) -> Spheroid
+        __init__(Spheroid self, vdouble1d_T P) -> Spheroid
         """
         _libBornAgainSample.Spheroid_swiginit(self, _libBornAgainSample.new_Spheroid(*args))
 
@@ -5533,7 +5533,7 @@ class TruncatedSphere(IFormfactor):
     def __init__(self, *args):
         r"""
         __init__(TruncatedSphere self, double radius, double untruncated_height, double dh) -> TruncatedSphere
-        __init__(TruncatedSphere self, vdouble1d_t P) -> TruncatedSphere
+        __init__(TruncatedSphere self, vdouble1d_T P) -> TruncatedSphere
         """
         _libBornAgainSample.TruncatedSphere_swiginit(self, _libBornAgainSample.new_TruncatedSphere(*args))
 
@@ -5593,7 +5593,7 @@ class TruncatedSpheroid(IFormfactor):
     def __init__(self, *args):
         r"""
         __init__(TruncatedSpheroid self, double radius, double untruncated_height, double untruncated_height_flattening, double dh) -> TruncatedSpheroid
-        __init__(TruncatedSpheroid self, vdouble1d_t P) -> TruncatedSpheroid
+        __init__(TruncatedSpheroid self, vdouble1d_T P) -> TruncatedSpheroid
         """
         _libBornAgainSample.TruncatedSpheroid_swiginit(self, _libBornAgainSample.new_TruncatedSpheroid(*args))
 
@@ -5657,7 +5657,7 @@ class BarGauss(IProfileRectangularRipple):
     def __init__(self, *args):
         r"""
         __init__(BarGauss self, double length, double width, double height) -> BarGauss
-        __init__(BarGauss self, vdouble1d_t P) -> BarGauss
+        __init__(BarGauss self, vdouble1d_T P) -> BarGauss
         """
         _libBornAgainSample.BarGauss_swiginit(self, _libBornAgainSample.new_BarGauss(*args))
 
@@ -5689,7 +5689,7 @@ class BarLorentz(IProfileRectangularRipple):
     def __init__(self, *args):
         r"""
         __init__(BarLorentz self, double length, double width, double height) -> BarLorentz
-        __init__(BarLorentz self, vdouble1d_t P) -> BarLorentz
+        __init__(BarLorentz self, vdouble1d_T P) -> BarLorentz
         """
         _libBornAgainSample.BarLorentz_swiginit(self, _libBornAgainSample.new_BarLorentz(*args))
 
@@ -5721,7 +5721,7 @@ class CosineRippleBox(ICosineRipple):
     def __init__(self, *args):
         r"""
         __init__(CosineRippleBox self, double length, double width, double height) -> CosineRippleBox
-        __init__(CosineRippleBox self, vdouble1d_t P) -> CosineRippleBox
+        __init__(CosineRippleBox self, vdouble1d_T P) -> CosineRippleBox
         """
         _libBornAgainSample.CosineRippleBox_swiginit(self, _libBornAgainSample.new_CosineRippleBox(*args))
 
@@ -5753,7 +5753,7 @@ class CosineRippleGauss(ICosineRipple):
     def __init__(self, *args):
         r"""
         __init__(CosineRippleGauss self, double length, double width, double height) -> CosineRippleGauss
-        __init__(CosineRippleGauss self, vdouble1d_t P) -> CosineRippleGauss
+        __init__(CosineRippleGauss self, vdouble1d_T P) -> CosineRippleGauss
         """
         _libBornAgainSample.CosineRippleGauss_swiginit(self, _libBornAgainSample.new_CosineRippleGauss(*args))
 
@@ -5785,7 +5785,7 @@ class CosineRippleLorentz(ICosineRipple):
     def __init__(self, *args):
         r"""
         __init__(CosineRippleLorentz self, double length, double width, double height) -> CosineRippleLorentz
-        __init__(CosineRippleLorentz self, vdouble1d_t P) -> CosineRippleLorentz
+        __init__(CosineRippleLorentz self, vdouble1d_T P) -> CosineRippleLorentz
         """
         _libBornAgainSample.CosineRippleLorentz_swiginit(self, _libBornAgainSample.new_CosineRippleLorentz(*args))
 
@@ -5817,7 +5817,7 @@ class SawtoothRippleBox(ISawtoothRipple):
     def __init__(self, *args):
         r"""
         __init__(SawtoothRippleBox self, double length, double width, double height, double asymmetry) -> SawtoothRippleBox
-        __init__(SawtoothRippleBox self, vdouble1d_t P) -> SawtoothRippleBox
+        __init__(SawtoothRippleBox self, vdouble1d_T P) -> SawtoothRippleBox
         """
         _libBornAgainSample.SawtoothRippleBox_swiginit(self, _libBornAgainSample.new_SawtoothRippleBox(*args))
 
@@ -5849,7 +5849,7 @@ class SawtoothRippleGauss(ISawtoothRipple):
     def __init__(self, *args):
         r"""
         __init__(SawtoothRippleGauss self, double length, double width, double height, double asymmetry) -> SawtoothRippleGauss
-        __init__(SawtoothRippleGauss self, vdouble1d_t P) -> SawtoothRippleGauss
+        __init__(SawtoothRippleGauss self, vdouble1d_T P) -> SawtoothRippleGauss
         """
         _libBornAgainSample.SawtoothRippleGauss_swiginit(self, _libBornAgainSample.new_SawtoothRippleGauss(*args))
 
@@ -5881,7 +5881,7 @@ class SawtoothRippleLorentz(ISawtoothRipple):
     def __init__(self, *args):
         r"""
         __init__(SawtoothRippleLorentz self, double length, double width, double height, double asymmetry) -> SawtoothRippleLorentz
-        __init__(SawtoothRippleLorentz self, vdouble1d_t P) -> SawtoothRippleLorentz
+        __init__(SawtoothRippleLorentz self, vdouble1d_T P) -> SawtoothRippleLorentz
         """
         _libBornAgainSample.SawtoothRippleLorentz_swiginit(self, _libBornAgainSample.new_SawtoothRippleLorentz(*args))
 
@@ -5913,7 +5913,7 @@ class LongBoxGauss(IFormfactor):
     def __init__(self, *args):
         r"""
         __init__(LongBoxGauss self, double length, double width, double height) -> LongBoxGauss
-        __init__(LongBoxGauss self, vdouble1d_t P) -> LongBoxGauss
+        __init__(LongBoxGauss self, vdouble1d_T P) -> LongBoxGauss
         """
         _libBornAgainSample.LongBoxGauss_swiginit(self, _libBornAgainSample.new_LongBoxGauss(*args))
 
@@ -5969,7 +5969,7 @@ class LongBoxLorentz(IFormfactor):
     def __init__(self, *args):
         r"""
         __init__(LongBoxLorentz self, double length, double width, double height) -> LongBoxLorentz
-        __init__(LongBoxLorentz self, vdouble1d_t P) -> LongBoxLorentz
+        __init__(LongBoxLorentz self, vdouble1d_T P) -> LongBoxLorentz
         """
         _libBornAgainSample.LongBoxLorentz_swiginit(self, _libBornAgainSample.new_LongBoxLorentz(*args))
 
@@ -6024,7 +6024,7 @@ class GaussSphere(IFormfactor):
 
     def __init__(self, *args):
         r"""
-        __init__(GaussSphere self, vdouble1d_t P) -> GaussSphere
+        __init__(GaussSphere self, vdouble1d_T P) -> GaussSphere
         __init__(GaussSphere self, double mean_radius) -> GaussSphere
         """
         _libBornAgainSample.GaussSphere_swiginit(self, _libBornAgainSample.new_GaussSphere(*args))
@@ -6072,7 +6072,7 @@ class FuzzySphere(IFormfactor):
 
     def __init__(self, *args):
         r"""
-        __init__(FuzzySphere self, vdouble1d_t P) -> FuzzySphere
+        __init__(FuzzySphere self, vdouble1d_T P) -> FuzzySphere
         __init__(FuzzySphere self, double mean, double sigma) -> FuzzySphere
         """
         _libBornAgainSample.FuzzySphere_swiginit(self, _libBornAgainSample.new_FuzzySphere(*args))
diff --git a/auto/Wrap/libBornAgainSample_wrap.cpp b/auto/Wrap/libBornAgainSample_wrap.cpp
index ba2bf939743ccb7988270fb24ae31e15c6c0b7de..8b8857e3af52ad7ed405c3abb9447f8f3259cafd 100644
--- a/auto/Wrap/libBornAgainSample_wrap.cpp
+++ b/auto/Wrap/libBornAgainSample_wrap.cpp
@@ -8872,7 +8872,7 @@ SWIGINTERN PyObject *SwigPyIterator_swigregister(PyObject *SWIGUNUSEDPARM(self),
   return SWIG_Py_Void();
 }
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_iterator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_iterator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   PyObject **arg2 = (PyObject **) 0 ;
@@ -8887,7 +8887,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_iterator(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_iterator" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_iterator" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = (swig::SwigPyIterator *)std_vector_Sl_double_Sg__iterator(arg1,arg2);
@@ -8898,7 +8898,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___nonzero__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___nonzero__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -8911,7 +8911,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___nonzero__(PyObject *self, PyObject *arg
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___nonzero__" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___nonzero__" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = (bool)std_vector_Sl_double_Sg____nonzero__((std::vector< double > const *)arg1);
@@ -8922,7 +8922,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___bool__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___bool__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -8935,7 +8935,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___bool__(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___bool__" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___bool__" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = (bool)std_vector_Sl_double_Sg____bool__((std::vector< double > const *)arg1);
@@ -8946,7 +8946,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___len__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___len__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -8959,7 +8959,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___len__(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___len__" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___len__" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = std_vector_Sl_double_Sg____len__((std::vector< double > const *)arg1);
@@ -8970,7 +8970,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___getslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___getslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::difference_type arg2 ;
@@ -8985,20 +8985,20 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___getslice__(PyObject *self, PyObject *ar
   std::vector< double,std::allocator< double > > *result = 0 ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_t___getslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_T___getslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___getslice__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___getslice__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t___getslice__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T___getslice__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< double >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_t___getslice__" "', argument " "3"" of type '" "std::vector< double >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_T___getslice__" "', argument " "3"" of type '" "std::vector< double >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< double >::difference_type >(val3);
   try {
@@ -9015,7 +9015,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::difference_type arg2 ;
@@ -9031,17 +9031,17 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setslice____SWIG_0(PyObject *self, Py_s
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___setslice__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___setslice__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t___setslice__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T___setslice__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< double >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_t___setslice__" "', argument " "3"" of type '" "std::vector< double >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_T___setslice__" "', argument " "3"" of type '" "std::vector< double >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< double >::difference_type >(val3);
   try {
@@ -9058,7 +9058,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::difference_type arg2 ;
@@ -9076,27 +9076,27 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setslice____SWIG_1(PyObject *self, Py_s
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___setslice__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___setslice__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t___setslice__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T___setslice__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< double >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_t___setslice__" "', argument " "3"" of type '" "std::vector< double >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_T___setslice__" "', argument " "3"" of type '" "std::vector< double >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< double >::difference_type >(val3);
   {
     std::vector< double,std::allocator< double > > *ptr = (std::vector< double,std::allocator< double > > *)0;
     res4 = swig::asptr(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vdouble1d_t___setslice__" "', argument " "4"" of type '" "std::vector< double,std::allocator< double > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vdouble1d_T___setslice__" "', argument " "4"" of type '" "std::vector< double,std::allocator< double > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble1d_t___setslice__" "', argument " "4"" of type '" "std::vector< double,std::allocator< double > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble1d_T___setslice__" "', argument " "4"" of type '" "std::vector< double,std::allocator< double > > const &""'"); 
     }
     arg4 = ptr;
   }
@@ -9116,13 +9116,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___setslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___setslice__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_t___setslice__", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_T___setslice__", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -9139,7 +9139,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setslice__(PyObject *self, PyObject *ar
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vdouble1d_t___setslice____SWIG_0(self, argc, argv);
+          return _wrap_vdouble1d_T___setslice____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -9162,7 +9162,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setslice__(PyObject *self, PyObject *ar
           int res = swig::asptr(argv[3], (std::vector< double,std::allocator< double > >**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vdouble1d_t___setslice____SWIG_1(self, argc, argv);
+            return _wrap_vdouble1d_T___setslice____SWIG_1(self, argc, argv);
           }
         }
       }
@@ -9170,7 +9170,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setslice__(PyObject *self, PyObject *ar
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_t___setslice__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_T___setslice__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< double >::__setslice__(std::vector< double >::difference_type,std::vector< double >::difference_type)\n"
     "    std::vector< double >::__setslice__(std::vector< double >::difference_type,std::vector< double >::difference_type,std::vector< double,std::allocator< double > > const &)\n");
@@ -9178,7 +9178,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___delslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___delslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::difference_type arg2 ;
@@ -9192,20 +9192,20 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___delslice__(PyObject *self, PyObject *ar
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_t___delslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_T___delslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___delslice__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___delslice__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t___delslice__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T___delslice__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< double >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_t___delslice__" "', argument " "3"" of type '" "std::vector< double >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_T___delslice__" "', argument " "3"" of type '" "std::vector< double >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< double >::difference_type >(val3);
   try {
@@ -9222,7 +9222,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::difference_type arg2 ;
@@ -9235,12 +9235,12 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___delitem____SWIG_0(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___delitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___delitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t___delitem__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T___delitem__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< double >::difference_type >(val2);
   try {
@@ -9257,7 +9257,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -9269,12 +9269,12 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___getitem____SWIG_0(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___getitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___getitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -9292,7 +9292,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -9305,12 +9305,12 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setitem____SWIG_0(PyObject *self, Py_ss
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___setitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___setitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -9318,10 +9318,10 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setitem____SWIG_0(PyObject *self, Py_ss
     std::vector< double,std::allocator< double > > *ptr = (std::vector< double,std::allocator< double > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble1d_t___setitem__" "', argument " "3"" of type '" "std::vector< double,std::allocator< double > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble1d_T___setitem__" "', argument " "3"" of type '" "std::vector< double,std::allocator< double > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble1d_t___setitem__" "', argument " "3"" of type '" "std::vector< double,std::allocator< double > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble1d_T___setitem__" "', argument " "3"" of type '" "std::vector< double,std::allocator< double > > const &""'"); 
     }
     arg3 = ptr;
   }
@@ -9341,7 +9341,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -9352,12 +9352,12 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setitem____SWIG_1(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___setitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___setitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -9375,7 +9375,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -9386,12 +9386,12 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___delitem____SWIG_1(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___delitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___delitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -9409,13 +9409,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___delitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___delitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_t___delitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_T___delitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -9426,7 +9426,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___delitem__(PyObject *self, PyObject *arg
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vdouble1d_t___delitem____SWIG_1(self, argc, argv);
+        return _wrap_vdouble1d_T___delitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -9440,13 +9440,13 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___delitem__(PyObject *self, PyObject *arg
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vdouble1d_t___delitem____SWIG_0(self, argc, argv);
+        return _wrap_vdouble1d_T___delitem____SWIG_0(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_t___delitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_T___delitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< double >::__delitem__(std::vector< double >::difference_type)\n"
     "    std::vector< double >::__delitem__(SWIGPY_SLICEOBJECT *)\n");
@@ -9454,7 +9454,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::difference_type arg2 ;
@@ -9468,12 +9468,12 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___getitem____SWIG_1(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___getitem__" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___getitem__" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t___getitem__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T___getitem__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< double >::difference_type >(val2);
   try {
@@ -9489,13 +9489,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___getitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___getitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_t___getitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_T___getitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -9506,7 +9506,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___getitem__(PyObject *self, PyObject *arg
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vdouble1d_t___getitem____SWIG_0(self, argc, argv);
+        return _wrap_vdouble1d_T___getitem____SWIG_0(self, argc, argv);
       }
     }
   }
@@ -9520,13 +9520,13 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___getitem__(PyObject *self, PyObject *arg
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vdouble1d_t___getitem____SWIG_1(self, argc, argv);
+        return _wrap_vdouble1d_T___getitem____SWIG_1(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_t___getitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_T___getitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< double >::__getitem__(SWIGPY_SLICEOBJECT *)\n"
     "    std::vector< double >::__getitem__(std::vector< double >::difference_type) const\n");
@@ -9534,7 +9534,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::difference_type arg2 ;
@@ -9551,17 +9551,17 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setitem____SWIG_2(PyObject *self, Py_ss
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___setitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___setitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t___setitem__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T___setitem__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< double >::difference_type >(val2);
   ecode3 = SWIG_AsVal_double(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_t___setitem__" "', argument " "3"" of type '" "std::vector< double >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_T___setitem__" "', argument " "3"" of type '" "std::vector< double >::value_type""'");
   } 
   temp3 = static_cast< std::vector< double >::value_type >(val3);
   arg3 = &temp3;
@@ -9577,13 +9577,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___setitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___setitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_t___setitem__", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_T___setitem__", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -9594,7 +9594,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setitem__(PyObject *self, PyObject *arg
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vdouble1d_t___setitem____SWIG_1(self, argc, argv);
+        return _wrap_vdouble1d_T___setitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -9610,7 +9610,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setitem__(PyObject *self, PyObject *arg
         int res = swig::asptr(argv[2], (std::vector< double,std::allocator< double > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vdouble1d_t___setitem____SWIG_0(self, argc, argv);
+          return _wrap_vdouble1d_T___setitem____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -9630,14 +9630,14 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setitem__(PyObject *self, PyObject *arg
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vdouble1d_t___setitem____SWIG_2(self, argc, argv);
+          return _wrap_vdouble1d_T___setitem____SWIG_2(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_t___setitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_T___setitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< double >::__setitem__(SWIGPY_SLICEOBJECT *,std::vector< double,std::allocator< double > > const &)\n"
     "    std::vector< double >::__setitem__(SWIGPY_SLICEOBJECT *)\n"
@@ -9646,7 +9646,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_pop(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_pop(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -9659,7 +9659,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_pop(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_pop" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_pop" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   try {
@@ -9674,7 +9674,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_append(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_append(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::value_type *arg2 = 0 ;
@@ -9686,15 +9686,15 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_append(PyObject *self, PyObject *args) {
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_t_append", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_T_append", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_append" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_append" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_double(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t_append" "', argument " "2"" of type '" "std::vector< double >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T_append" "', argument " "2"" of type '" "std::vector< double >::value_type""'");
   } 
   temp2 = static_cast< std::vector< double >::value_type >(val2);
   arg2 = &temp2;
@@ -9706,7 +9706,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vdouble1d_t__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
+SWIGINTERN PyObject *_wrap_new_vdouble1d_T__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
   PyObject *resultobj = 0;
   std::vector< double > *result = 0 ;
   
@@ -9720,7 +9720,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vdouble1d_t__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vdouble1d_T__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = 0 ;
   int res1 = SWIG_OLDOBJ ;
@@ -9732,10 +9732,10 @@ SWIGINTERN PyObject *_wrap_new_vdouble1d_t__SWIG_1(PyObject *self, Py_ssize_t no
     std::vector< double,std::allocator< double > > *ptr = (std::vector< double,std::allocator< double > > *)0;
     res1 = swig::asptr(swig_obj[0], &ptr);
     if (!SWIG_IsOK(res1)) {
-      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vdouble1d_t" "', argument " "1"" of type '" "std::vector< double > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vdouble1d_T" "', argument " "1"" of type '" "std::vector< double > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vdouble1d_t" "', argument " "1"" of type '" "std::vector< double > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vdouble1d_T" "', argument " "1"" of type '" "std::vector< double > const &""'"); 
     }
     arg1 = ptr;
   }
@@ -9749,7 +9749,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_empty(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_empty(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -9762,7 +9762,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_empty(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_empty" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_empty" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = (bool)((std::vector< double > const *)arg1)->empty();
@@ -9773,7 +9773,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_size(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_size(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -9786,7 +9786,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_size(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_size" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_size" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = ((std::vector< double > const *)arg1)->size();
@@ -9797,7 +9797,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_swap(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_swap(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double > *arg2 = 0 ;
@@ -9808,18 +9808,18 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_swap(PyObject *self, PyObject *args) {
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_t_swap", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_T_swap", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_swap" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_swap" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], &argp2, SWIGTYPE_p_std__vectorT_double_t,  0 );
   if (!SWIG_IsOK(res2)) {
-    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vdouble1d_t_swap" "', argument " "2"" of type '" "std::vector< double > &""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vdouble1d_T_swap" "', argument " "2"" of type '" "std::vector< double > &""'"); 
   }
   if (!argp2) {
-    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble1d_t_swap" "', argument " "2"" of type '" "std::vector< double > &""'"); 
+    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble1d_T_swap" "', argument " "2"" of type '" "std::vector< double > &""'"); 
   }
   arg2 = reinterpret_cast< std::vector< double > * >(argp2);
   (arg1)->swap(*arg2);
@@ -9830,7 +9830,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_begin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_begin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -9843,7 +9843,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_begin(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_begin" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_begin" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = (arg1)->begin();
@@ -9855,7 +9855,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_end(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_end(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -9868,7 +9868,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_end(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_end" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_end" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = (arg1)->end();
@@ -9880,7 +9880,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_rbegin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_rbegin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -9893,7 +9893,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_rbegin(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_rbegin" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_rbegin" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = (arg1)->rbegin();
@@ -9905,7 +9905,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_rend(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_rend(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -9918,7 +9918,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_rend(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_rend" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_rend" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = (arg1)->rend();
@@ -9930,7 +9930,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_clear(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_clear(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -9942,7 +9942,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_clear(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_clear" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_clear" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   (arg1)->clear();
@@ -9953,7 +9953,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_get_allocator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_get_allocator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -9966,7 +9966,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_get_allocator(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_get_allocator" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_get_allocator" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = ((std::vector< double > const *)arg1)->get_allocator();
@@ -9977,7 +9977,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vdouble1d_t__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vdouble1d_T__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double >::size_type arg1 ;
   size_t val1 ;
@@ -9988,7 +9988,7 @@ SWIGINTERN PyObject *_wrap_new_vdouble1d_t__SWIG_2(PyObject *self, Py_ssize_t no
   if ((nobjs < 1) || (nobjs > 1)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vdouble1d_t" "', argument " "1"" of type '" "std::vector< double >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vdouble1d_T" "', argument " "1"" of type '" "std::vector< double >::size_type""'");
   } 
   arg1 = static_cast< std::vector< double >::size_type >(val1);
   result = (std::vector< double > *)new std::vector< double >(arg1);
@@ -9999,7 +9999,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_pop_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_pop_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -10011,7 +10011,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_pop_back(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_pop_back" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_pop_back" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   (arg1)->pop_back();
@@ -10022,7 +10022,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::size_type arg2 ;
@@ -10035,12 +10035,12 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_resize__SWIG_0(PyObject *self, Py_ssize_t
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_resize" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_resize" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t_resize" "', argument " "2"" of type '" "std::vector< double >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T_resize" "', argument " "2"" of type '" "std::vector< double >::size_type""'");
   } 
   arg2 = static_cast< std::vector< double >::size_type >(val2);
   (arg1)->resize(arg2);
@@ -10051,7 +10051,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::iterator arg2 ;
@@ -10065,18 +10065,18 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_erase__SWIG_0(PyObject *self, Py_ssize_t
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_erase" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_erase" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t_erase" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T_erase" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< double >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< double >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t_erase" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T_erase" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
     }
   }
   result = std_vector_Sl_double_Sg__erase__SWIG_0(arg1,SWIG_STD_MOVE(arg2));
@@ -10088,7 +10088,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::iterator arg2 ;
@@ -10105,29 +10105,29 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_erase__SWIG_1(PyObject *self, Py_ssize_t
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_erase" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_erase" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t_erase" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T_erase" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< double >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< double >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t_erase" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T_erase" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
     }
   }
   res3 = SWIG_ConvertPtr(swig_obj[2], SWIG_as_voidptrptr(&iter3), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res3) || !iter3) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t_erase" "', argument " "3"" of type '" "std::vector< double >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T_erase" "', argument " "3"" of type '" "std::vector< double >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< double >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< double >::iterator > *>(iter3);
     if (iter_t) {
       arg3 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t_erase" "', argument " "3"" of type '" "std::vector< double >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T_erase" "', argument " "3"" of type '" "std::vector< double >::iterator""'");
     }
   }
   result = std_vector_Sl_double_Sg__erase__SWIG_1(arg1,SWIG_STD_MOVE(arg2),SWIG_STD_MOVE(arg3));
@@ -10139,13 +10139,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_erase(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_erase(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_t_erase", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_T_erase", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -10156,7 +10156,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_erase(PyObject *self, PyObject *args) {
       int res = SWIG_ConvertPtr(argv[1], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
       _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< double >::iterator > *>(iter) != 0));
       if (_v) {
-        return _wrap_vdouble1d_t_erase__SWIG_0(self, argc, argv);
+        return _wrap_vdouble1d_T_erase__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -10173,14 +10173,14 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_erase(PyObject *self, PyObject *args) {
         int res = SWIG_ConvertPtr(argv[2], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
         _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< double >::iterator > *>(iter) != 0));
         if (_v) {
-          return _wrap_vdouble1d_t_erase__SWIG_1(self, argc, argv);
+          return _wrap_vdouble1d_T_erase__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_t_erase'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_T_erase'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< double >::erase(std::vector< double >::iterator)\n"
     "    std::vector< double >::erase(std::vector< double >::iterator,std::vector< double >::iterator)\n");
@@ -10188,7 +10188,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vdouble1d_t__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vdouble1d_T__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double >::size_type arg1 ;
   std::vector< double >::value_type *arg2 = 0 ;
@@ -10203,12 +10203,12 @@ SWIGINTERN PyObject *_wrap_new_vdouble1d_t__SWIG_3(PyObject *self, Py_ssize_t no
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vdouble1d_t" "', argument " "1"" of type '" "std::vector< double >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vdouble1d_T" "', argument " "1"" of type '" "std::vector< double >::size_type""'");
   } 
   arg1 = static_cast< std::vector< double >::size_type >(val1);
   ecode2 = SWIG_AsVal_double(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "new_vdouble1d_t" "', argument " "2"" of type '" "std::vector< double >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "new_vdouble1d_T" "', argument " "2"" of type '" "std::vector< double >::value_type""'");
   } 
   temp2 = static_cast< std::vector< double >::value_type >(val2);
   arg2 = &temp2;
@@ -10220,16 +10220,16 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vdouble1d_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_new_vdouble1d_T(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vdouble1d_t", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vdouble1d_T", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 0) {
-    return _wrap_new_vdouble1d_t__SWIG_0(self, argc, argv);
+    return _wrap_new_vdouble1d_T__SWIG_0(self, argc, argv);
   }
   if (argc == 1) {
     int _v = 0;
@@ -10238,7 +10238,7 @@ SWIGINTERN PyObject *_wrap_new_vdouble1d_t(PyObject *self, PyObject *args) {
       _v = SWIG_CheckState(res);
     }
     if (_v) {
-      return _wrap_new_vdouble1d_t__SWIG_2(self, argc, argv);
+      return _wrap_new_vdouble1d_T__SWIG_2(self, argc, argv);
     }
   }
   if (argc == 1) {
@@ -10246,7 +10246,7 @@ SWIGINTERN PyObject *_wrap_new_vdouble1d_t(PyObject *self, PyObject *args) {
     int res = swig::asptr(argv[0], (std::vector< double,std::allocator< double > >**)(0));
     _v = SWIG_CheckState(res);
     if (_v) {
-      return _wrap_new_vdouble1d_t__SWIG_1(self, argc, argv);
+      return _wrap_new_vdouble1d_T__SWIG_1(self, argc, argv);
     }
   }
   if (argc == 2) {
@@ -10261,13 +10261,13 @@ SWIGINTERN PyObject *_wrap_new_vdouble1d_t(PyObject *self, PyObject *args) {
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_new_vdouble1d_t__SWIG_3(self, argc, argv);
+        return _wrap_new_vdouble1d_T__SWIG_3(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vdouble1d_t'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vdouble1d_T'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< double >::vector()\n"
     "    std::vector< double >::vector(std::vector< double > const &)\n"
@@ -10277,7 +10277,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_push_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_push_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::value_type *arg2 = 0 ;
@@ -10289,15 +10289,15 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_push_back(PyObject *self, PyObject *args)
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_t_push_back", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_T_push_back", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_push_back" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_push_back" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_double(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t_push_back" "', argument " "2"" of type '" "std::vector< double >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T_push_back" "', argument " "2"" of type '" "std::vector< double >::value_type""'");
   } 
   temp2 = static_cast< std::vector< double >::value_type >(val2);
   arg2 = &temp2;
@@ -10309,7 +10309,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_front(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_front(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -10322,7 +10322,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_front(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_front" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_front" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = (std::vector< double >::value_type *) &((std::vector< double > const *)arg1)->front();
@@ -10334,7 +10334,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -10347,7 +10347,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_back(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_back" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_back" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = (std::vector< double >::value_type *) &((std::vector< double > const *)arg1)->back();
@@ -10359,7 +10359,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_assign(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_assign(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::size_type arg2 ;
@@ -10374,20 +10374,20 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_assign(PyObject *self, PyObject *args) {
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_t_assign", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_T_assign", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_assign" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_assign" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t_assign" "', argument " "2"" of type '" "std::vector< double >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T_assign" "', argument " "2"" of type '" "std::vector< double >::size_type""'");
   } 
   arg2 = static_cast< std::vector< double >::size_type >(val2);
   ecode3 = SWIG_AsVal_double(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_t_assign" "', argument " "3"" of type '" "std::vector< double >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_T_assign" "', argument " "3"" of type '" "std::vector< double >::value_type""'");
   } 
   temp3 = static_cast< std::vector< double >::value_type >(val3);
   arg3 = &temp3;
@@ -10399,7 +10399,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::size_type arg2 ;
@@ -10416,17 +10416,17 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_resize__SWIG_1(PyObject *self, Py_ssize_t
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_resize" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_resize" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t_resize" "', argument " "2"" of type '" "std::vector< double >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T_resize" "', argument " "2"" of type '" "std::vector< double >::size_type""'");
   } 
   arg2 = static_cast< std::vector< double >::size_type >(val2);
   ecode3 = SWIG_AsVal_double(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_t_resize" "', argument " "3"" of type '" "std::vector< double >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_T_resize" "', argument " "3"" of type '" "std::vector< double >::value_type""'");
   } 
   temp3 = static_cast< std::vector< double >::value_type >(val3);
   arg3 = &temp3;
@@ -10438,13 +10438,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_resize(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_resize(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_t_resize", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_T_resize", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -10456,7 +10456,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_resize(PyObject *self, PyObject *args) {
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vdouble1d_t_resize__SWIG_0(self, argc, argv);
+        return _wrap_vdouble1d_T_resize__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -10475,14 +10475,14 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_resize(PyObject *self, PyObject *args) {
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vdouble1d_t_resize__SWIG_1(self, argc, argv);
+          return _wrap_vdouble1d_T_resize__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_t_resize'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_T_resize'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< double >::resize(std::vector< double >::size_type)\n"
     "    std::vector< double >::resize(std::vector< double >::size_type,std::vector< double >::value_type const &)\n");
@@ -10490,7 +10490,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::iterator arg2 ;
@@ -10508,23 +10508,23 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_insert__SWIG_0(PyObject *self, Py_ssize_t
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_insert" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_insert" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t_insert" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T_insert" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< double >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< double >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t_insert" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T_insert" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_double(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_t_insert" "', argument " "3"" of type '" "std::vector< double >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_T_insert" "', argument " "3"" of type '" "std::vector< double >::value_type""'");
   } 
   temp3 = static_cast< std::vector< double >::value_type >(val3);
   arg3 = &temp3;
@@ -10537,7 +10537,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::iterator arg2 ;
@@ -10557,28 +10557,28 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_insert__SWIG_1(PyObject *self, Py_ssize_t
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_insert" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_insert" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t_insert" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T_insert" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< double >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< double >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t_insert" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T_insert" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_size_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_t_insert" "', argument " "3"" of type '" "std::vector< double >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_T_insert" "', argument " "3"" of type '" "std::vector< double >::size_type""'");
   } 
   arg3 = static_cast< std::vector< double >::size_type >(val3);
   ecode4 = SWIG_AsVal_double(swig_obj[3], &val4);
   if (!SWIG_IsOK(ecode4)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode4), "in method '" "vdouble1d_t_insert" "', argument " "4"" of type '" "std::vector< double >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode4), "in method '" "vdouble1d_T_insert" "', argument " "4"" of type '" "std::vector< double >::value_type""'");
   } 
   temp4 = static_cast< std::vector< double >::value_type >(val4);
   arg4 = &temp4;
@@ -10590,13 +10590,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_insert(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_insert(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_t_insert", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_T_insert", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -10612,7 +10612,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_insert(PyObject *self, PyObject *args) {
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vdouble1d_t_insert__SWIG_0(self, argc, argv);
+          return _wrap_vdouble1d_T_insert__SWIG_0(self, argc, argv);
         }
       }
     }
@@ -10636,7 +10636,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_insert(PyObject *self, PyObject *args) {
             _v = SWIG_CheckState(res);
           }
           if (_v) {
-            return _wrap_vdouble1d_t_insert__SWIG_1(self, argc, argv);
+            return _wrap_vdouble1d_T_insert__SWIG_1(self, argc, argv);
           }
         }
       }
@@ -10644,7 +10644,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_insert(PyObject *self, PyObject *args) {
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_t_insert'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_T_insert'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< double >::insert(std::vector< double >::iterator,std::vector< double >::value_type const &)\n"
     "    std::vector< double >::insert(std::vector< double >::iterator,std::vector< double >::size_type,std::vector< double >::value_type const &)\n");
@@ -10652,7 +10652,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_reserve(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_reserve(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::size_type arg2 ;
@@ -10663,15 +10663,15 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_reserve(PyObject *self, PyObject *args) {
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_t_reserve", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_T_reserve", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_reserve" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_reserve" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t_reserve" "', argument " "2"" of type '" "std::vector< double >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T_reserve" "', argument " "2"" of type '" "std::vector< double >::size_type""'");
   } 
   arg2 = static_cast< std::vector< double >::size_type >(val2);
   (arg1)->reserve(arg2);
@@ -10682,7 +10682,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_capacity(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_capacity(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -10695,7 +10695,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_capacity(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_capacity" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_capacity" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = ((std::vector< double > const *)arg1)->capacity();
@@ -10706,7 +10706,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_delete_vdouble1d_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_delete_vdouble1d_T(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -10718,7 +10718,7 @@ SWIGINTERN PyObject *_wrap_delete_vdouble1d_t(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, SWIG_POINTER_DISOWN |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vdouble1d_t" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vdouble1d_T" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   {
@@ -10739,18 +10739,18 @@ fail:
 }
 
 
-SWIGINTERN PyObject *vdouble1d_t_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vdouble1d_T_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   PyObject *obj;
   if (!SWIG_Python_UnpackTuple(args, "swigregister", 1, 1, &obj)) return NULL;
   SWIG_TypeNewClientData(SWIGTYPE_p_std__vectorT_double_t, SWIG_NewClientData(obj));
   return SWIG_Py_Void();
 }
 
-SWIGINTERN PyObject *vdouble1d_t_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vdouble1d_T_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   return SWIG_Python_InitShadowInstance(args);
 }
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_iterator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_iterator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   PyObject **arg2 = (PyObject **) 0 ;
@@ -10765,7 +10765,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_iterator(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_iterator" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_iterator" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = (swig::SwigPyIterator *)std_vector_Sl_std_vector_Sl_double_Sg__Sg__iterator(arg1,arg2);
@@ -10776,7 +10776,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___nonzero__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___nonzero__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -10789,7 +10789,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___nonzero__(PyObject *self, PyObject *arg
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___nonzero__" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___nonzero__" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = (bool)std_vector_Sl_std_vector_Sl_double_Sg__Sg____nonzero__((std::vector< std::vector< double > > const *)arg1);
@@ -10800,7 +10800,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___bool__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___bool__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -10813,7 +10813,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___bool__(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___bool__" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___bool__" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = (bool)std_vector_Sl_std_vector_Sl_double_Sg__Sg____bool__((std::vector< std::vector< double > > const *)arg1);
@@ -10824,7 +10824,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___len__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___len__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -10837,7 +10837,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___len__(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___len__" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___len__" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = std_vector_Sl_std_vector_Sl_double_Sg__Sg____len__((std::vector< std::vector< double > > const *)arg1);
@@ -10848,7 +10848,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___getslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___getslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::difference_type arg2 ;
@@ -10863,20 +10863,20 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___getslice__(PyObject *self, PyObject *ar
   std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > *result = 0 ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_t___getslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_T___getslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___getslice__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___getslice__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_t___getslice__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_T___getslice__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble2d_t___getslice__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble2d_T___getslice__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::vector< double > >::difference_type >(val3);
   try {
@@ -10893,7 +10893,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::difference_type arg2 ;
@@ -10909,17 +10909,17 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setslice____SWIG_0(PyObject *self, Py_s
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___setslice__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___setslice__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_t___setslice__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_T___setslice__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble2d_t___setslice__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble2d_T___setslice__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::vector< double > >::difference_type >(val3);
   try {
@@ -10936,7 +10936,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::difference_type arg2 ;
@@ -10954,27 +10954,27 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setslice____SWIG_1(PyObject *self, Py_s
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___setslice__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___setslice__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_t___setslice__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_T___setslice__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble2d_t___setslice__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble2d_T___setslice__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::vector< double > >::difference_type >(val3);
   {
     std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > *ptr = (std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > *)0;
     res4 = swig::asptr(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vdouble2d_t___setslice__" "', argument " "4"" of type '" "std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vdouble2d_T___setslice__" "', argument " "4"" of type '" "std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_t___setslice__" "', argument " "4"" of type '" "std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_T___setslice__" "', argument " "4"" of type '" "std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > const &""'"); 
     }
     arg4 = ptr;
   }
@@ -10994,13 +10994,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___setslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___setslice__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_t___setslice__", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_T___setslice__", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -11017,7 +11017,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setslice__(PyObject *self, PyObject *ar
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vdouble2d_t___setslice____SWIG_0(self, argc, argv);
+          return _wrap_vdouble2d_T___setslice____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -11040,7 +11040,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setslice__(PyObject *self, PyObject *ar
           int res = swig::asptr(argv[3], (std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > >**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vdouble2d_t___setslice____SWIG_1(self, argc, argv);
+            return _wrap_vdouble2d_T___setslice____SWIG_1(self, argc, argv);
           }
         }
       }
@@ -11048,7 +11048,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setslice__(PyObject *self, PyObject *ar
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_t___setslice__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_T___setslice__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< double > >::__setslice__(std::vector< std::vector< double > >::difference_type,std::vector< std::vector< double > >::difference_type)\n"
     "    std::vector< std::vector< double > >::__setslice__(std::vector< std::vector< double > >::difference_type,std::vector< std::vector< double > >::difference_type,std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > const &)\n");
@@ -11056,7 +11056,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___delslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___delslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::difference_type arg2 ;
@@ -11070,20 +11070,20 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___delslice__(PyObject *self, PyObject *ar
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_t___delslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_T___delslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___delslice__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___delslice__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_t___delslice__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_T___delslice__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble2d_t___delslice__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble2d_T___delslice__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::vector< double > >::difference_type >(val3);
   try {
@@ -11100,7 +11100,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::difference_type arg2 ;
@@ -11113,12 +11113,12 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___delitem____SWIG_0(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___delitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___delitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_t___delitem__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_T___delitem__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< double > >::difference_type >(val2);
   try {
@@ -11135,7 +11135,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -11147,12 +11147,12 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___getitem____SWIG_0(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___getitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___getitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -11170,7 +11170,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -11183,12 +11183,12 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setitem____SWIG_0(PyObject *self, Py_ss
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -11196,10 +11196,10 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setitem____SWIG_0(PyObject *self, Py_ss
     std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > *ptr = (std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble2d_t___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble2d_T___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_t___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_T___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > const &""'"); 
     }
     arg3 = ptr;
   }
@@ -11219,7 +11219,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -11230,12 +11230,12 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setitem____SWIG_1(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -11253,7 +11253,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -11264,12 +11264,12 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___delitem____SWIG_1(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___delitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___delitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -11287,13 +11287,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___delitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___delitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_t___delitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_T___delitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -11304,7 +11304,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___delitem__(PyObject *self, PyObject *arg
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vdouble2d_t___delitem____SWIG_1(self, argc, argv);
+        return _wrap_vdouble2d_T___delitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -11318,13 +11318,13 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___delitem__(PyObject *self, PyObject *arg
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vdouble2d_t___delitem____SWIG_0(self, argc, argv);
+        return _wrap_vdouble2d_T___delitem____SWIG_0(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_t___delitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_T___delitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< double > >::__delitem__(std::vector< std::vector< double > >::difference_type)\n"
     "    std::vector< std::vector< double > >::__delitem__(SWIGPY_SLICEOBJECT *)\n");
@@ -11332,7 +11332,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::difference_type arg2 ;
@@ -11346,12 +11346,12 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___getitem____SWIG_1(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___getitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___getitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_t___getitem__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_T___getitem__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< double > >::difference_type >(val2);
   try {
@@ -11367,13 +11367,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___getitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___getitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_t___getitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_T___getitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -11384,7 +11384,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___getitem__(PyObject *self, PyObject *arg
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vdouble2d_t___getitem____SWIG_0(self, argc, argv);
+        return _wrap_vdouble2d_T___getitem____SWIG_0(self, argc, argv);
       }
     }
   }
@@ -11398,13 +11398,13 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___getitem__(PyObject *self, PyObject *arg
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vdouble2d_t___getitem____SWIG_1(self, argc, argv);
+        return _wrap_vdouble2d_T___getitem____SWIG_1(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_t___getitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_T___getitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< double > >::__getitem__(SWIGPY_SLICEOBJECT *)\n"
     "    std::vector< std::vector< double > >::__getitem__(std::vector< std::vector< double > >::difference_type) const\n");
@@ -11412,7 +11412,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::difference_type arg2 ;
@@ -11427,22 +11427,22 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setitem____SWIG_2(PyObject *self, Py_ss
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_t___setitem__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_T___setitem__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< double > >::difference_type >(val2);
   {
     std::vector< double,std::allocator< double > > *ptr = (std::vector< double,std::allocator< double > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble2d_t___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble2d_T___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_t___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_T___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -11460,13 +11460,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___setitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___setitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_t___setitem__", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_T___setitem__", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -11477,7 +11477,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setitem__(PyObject *self, PyObject *arg
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vdouble2d_t___setitem____SWIG_1(self, argc, argv);
+        return _wrap_vdouble2d_T___setitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -11493,7 +11493,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setitem__(PyObject *self, PyObject *arg
         int res = swig::asptr(argv[2], (std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vdouble2d_t___setitem____SWIG_0(self, argc, argv);
+          return _wrap_vdouble2d_T___setitem____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -11511,14 +11511,14 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setitem__(PyObject *self, PyObject *arg
         int res = swig::asptr(argv[2], (std::vector< double,std::allocator< double > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vdouble2d_t___setitem____SWIG_2(self, argc, argv);
+          return _wrap_vdouble2d_T___setitem____SWIG_2(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_t___setitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_T___setitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< double > >::__setitem__(SWIGPY_SLICEOBJECT *,std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > const &)\n"
     "    std::vector< std::vector< double > >::__setitem__(SWIGPY_SLICEOBJECT *)\n"
@@ -11527,7 +11527,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_pop(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_pop(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -11540,7 +11540,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_pop(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_pop" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_pop" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   try {
@@ -11555,7 +11555,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_append(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_append(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::value_type *arg2 = 0 ;
@@ -11565,20 +11565,20 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_append(PyObject *self, PyObject *args) {
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_t_append", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_T_append", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_append" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_append" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   {
     std::vector< double,std::allocator< double > > *ptr = (std::vector< double,std::allocator< double > > *)0;
     res2 = swig::asptr(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vdouble2d_t_append" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vdouble2d_T_append" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_t_append" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_T_append" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -11592,7 +11592,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vdouble2d_t__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
+SWIGINTERN PyObject *_wrap_new_vdouble2d_T__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *result = 0 ;
   
@@ -11606,7 +11606,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vdouble2d_t__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vdouble2d_T__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double,std::allocator< double > > > *arg1 = 0 ;
   int res1 = SWIG_OLDOBJ ;
@@ -11618,10 +11618,10 @@ SWIGINTERN PyObject *_wrap_new_vdouble2d_t__SWIG_1(PyObject *self, Py_ssize_t no
     std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > *ptr = (std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > *)0;
     res1 = swig::asptr(swig_obj[0], &ptr);
     if (!SWIG_IsOK(res1)) {
-      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vdouble2d_t" "', argument " "1"" of type '" "std::vector< std::vector< double,std::allocator< double > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vdouble2d_T" "', argument " "1"" of type '" "std::vector< std::vector< double,std::allocator< double > > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vdouble2d_t" "', argument " "1"" of type '" "std::vector< std::vector< double,std::allocator< double > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vdouble2d_T" "', argument " "1"" of type '" "std::vector< std::vector< double,std::allocator< double > > > const &""'"); 
     }
     arg1 = ptr;
   }
@@ -11635,7 +11635,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_empty(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_empty(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -11648,7 +11648,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_empty(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_empty" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_empty" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = (bool)((std::vector< std::vector< double > > const *)arg1)->empty();
@@ -11659,7 +11659,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_size(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_size(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -11672,7 +11672,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_size(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_size" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_size" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = ((std::vector< std::vector< double > > const *)arg1)->size();
@@ -11683,7 +11683,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_swap(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_swap(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double,std::allocator< double > > > *arg2 = 0 ;
@@ -11694,18 +11694,18 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_swap(PyObject *self, PyObject *args) {
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_t_swap", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_T_swap", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_swap" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_swap" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], &argp2, SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t,  0 );
   if (!SWIG_IsOK(res2)) {
-    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vdouble2d_t_swap" "', argument " "2"" of type '" "std::vector< std::vector< double,std::allocator< double > > > &""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vdouble2d_T_swap" "', argument " "2"" of type '" "std::vector< std::vector< double,std::allocator< double > > > &""'"); 
   }
   if (!argp2) {
-    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_t_swap" "', argument " "2"" of type '" "std::vector< std::vector< double,std::allocator< double > > > &""'"); 
+    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_T_swap" "', argument " "2"" of type '" "std::vector< std::vector< double,std::allocator< double > > > &""'"); 
   }
   arg2 = reinterpret_cast< std::vector< std::vector< double,std::allocator< double > > > * >(argp2);
   (arg1)->swap(*arg2);
@@ -11716,7 +11716,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_begin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_begin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -11729,7 +11729,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_begin(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_begin" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_begin" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = (arg1)->begin();
@@ -11741,7 +11741,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_end(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_end(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -11754,7 +11754,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_end(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_end" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_end" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = (arg1)->end();
@@ -11766,7 +11766,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_rbegin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_rbegin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -11779,7 +11779,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_rbegin(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_rbegin" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_rbegin" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = (arg1)->rbegin();
@@ -11791,7 +11791,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_rend(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_rend(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -11804,7 +11804,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_rend(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_rend" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_rend" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = (arg1)->rend();
@@ -11816,7 +11816,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_clear(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_clear(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -11828,7 +11828,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_clear(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_clear" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_clear" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   (arg1)->clear();
@@ -11839,7 +11839,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_get_allocator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_get_allocator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -11852,7 +11852,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_get_allocator(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_get_allocator" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_get_allocator" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = ((std::vector< std::vector< double > > const *)arg1)->get_allocator();
@@ -11863,7 +11863,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vdouble2d_t__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vdouble2d_T__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > >::size_type arg1 ;
   size_t val1 ;
@@ -11874,7 +11874,7 @@ SWIGINTERN PyObject *_wrap_new_vdouble2d_t__SWIG_2(PyObject *self, Py_ssize_t no
   if ((nobjs < 1) || (nobjs > 1)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vdouble2d_t" "', argument " "1"" of type '" "std::vector< std::vector< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vdouble2d_T" "', argument " "1"" of type '" "std::vector< std::vector< double > >::size_type""'");
   } 
   arg1 = static_cast< std::vector< std::vector< double > >::size_type >(val1);
   result = (std::vector< std::vector< double > > *)new std::vector< std::vector< double > >(arg1);
@@ -11885,7 +11885,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_pop_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_pop_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -11897,7 +11897,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_pop_back(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_pop_back" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_pop_back" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   (arg1)->pop_back();
@@ -11908,7 +11908,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::size_type arg2 ;
@@ -11921,12 +11921,12 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_resize__SWIG_0(PyObject *self, Py_ssize_t
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_resize" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_resize" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_t_resize" "', argument " "2"" of type '" "std::vector< std::vector< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_T_resize" "', argument " "2"" of type '" "std::vector< std::vector< double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< double > >::size_type >(val2);
   (arg1)->resize(arg2);
@@ -11937,7 +11937,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::iterator arg2 ;
@@ -11951,18 +11951,18 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_erase__SWIG_0(PyObject *self, Py_ssize_t
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_erase" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_erase" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t_erase" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T_erase" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t_erase" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T_erase" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
     }
   }
   result = std_vector_Sl_std_vector_Sl_double_Sg__Sg__erase__SWIG_0(arg1,SWIG_STD_MOVE(arg2));
@@ -11974,7 +11974,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::iterator arg2 ;
@@ -11991,29 +11991,29 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_erase__SWIG_1(PyObject *self, Py_ssize_t
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_erase" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_erase" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t_erase" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T_erase" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t_erase" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T_erase" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
     }
   }
   res3 = SWIG_ConvertPtr(swig_obj[2], SWIG_as_voidptrptr(&iter3), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res3) || !iter3) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t_erase" "', argument " "3"" of type '" "std::vector< std::vector< double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T_erase" "', argument " "3"" of type '" "std::vector< std::vector< double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *>(iter3);
     if (iter_t) {
       arg3 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t_erase" "', argument " "3"" of type '" "std::vector< std::vector< double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T_erase" "', argument " "3"" of type '" "std::vector< std::vector< double > >::iterator""'");
     }
   }
   result = std_vector_Sl_std_vector_Sl_double_Sg__Sg__erase__SWIG_1(arg1,SWIG_STD_MOVE(arg2),SWIG_STD_MOVE(arg3));
@@ -12025,13 +12025,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_erase(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_erase(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_t_erase", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_T_erase", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -12042,7 +12042,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_erase(PyObject *self, PyObject *args) {
       int res = SWIG_ConvertPtr(argv[1], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
       _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *>(iter) != 0));
       if (_v) {
-        return _wrap_vdouble2d_t_erase__SWIG_0(self, argc, argv);
+        return _wrap_vdouble2d_T_erase__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -12059,14 +12059,14 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_erase(PyObject *self, PyObject *args) {
         int res = SWIG_ConvertPtr(argv[2], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
         _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *>(iter) != 0));
         if (_v) {
-          return _wrap_vdouble2d_t_erase__SWIG_1(self, argc, argv);
+          return _wrap_vdouble2d_T_erase__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_t_erase'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_T_erase'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< double > >::erase(std::vector< std::vector< double > >::iterator)\n"
     "    std::vector< std::vector< double > >::erase(std::vector< std::vector< double > >::iterator,std::vector< std::vector< double > >::iterator)\n");
@@ -12074,7 +12074,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vdouble2d_t__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vdouble2d_T__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > >::size_type arg1 ;
   std::vector< std::vector< double > >::value_type *arg2 = 0 ;
@@ -12087,17 +12087,17 @@ SWIGINTERN PyObject *_wrap_new_vdouble2d_t__SWIG_3(PyObject *self, Py_ssize_t no
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vdouble2d_t" "', argument " "1"" of type '" "std::vector< std::vector< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vdouble2d_T" "', argument " "1"" of type '" "std::vector< std::vector< double > >::size_type""'");
   } 
   arg1 = static_cast< std::vector< std::vector< double > >::size_type >(val1);
   {
     std::vector< double,std::allocator< double > > *ptr = (std::vector< double,std::allocator< double > > *)0;
     res2 = swig::asptr(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "new_vdouble2d_t" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "new_vdouble2d_T" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vdouble2d_t" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vdouble2d_T" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -12111,16 +12111,16 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vdouble2d_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_new_vdouble2d_T(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vdouble2d_t", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vdouble2d_T", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 0) {
-    return _wrap_new_vdouble2d_t__SWIG_0(self, argc, argv);
+    return _wrap_new_vdouble2d_T__SWIG_0(self, argc, argv);
   }
   if (argc == 1) {
     int _v = 0;
@@ -12129,7 +12129,7 @@ SWIGINTERN PyObject *_wrap_new_vdouble2d_t(PyObject *self, PyObject *args) {
       _v = SWIG_CheckState(res);
     }
     if (_v) {
-      return _wrap_new_vdouble2d_t__SWIG_2(self, argc, argv);
+      return _wrap_new_vdouble2d_T__SWIG_2(self, argc, argv);
     }
   }
   if (argc == 1) {
@@ -12137,7 +12137,7 @@ SWIGINTERN PyObject *_wrap_new_vdouble2d_t(PyObject *self, PyObject *args) {
     int res = swig::asptr(argv[0], (std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > >**)(0));
     _v = SWIG_CheckState(res);
     if (_v) {
-      return _wrap_new_vdouble2d_t__SWIG_1(self, argc, argv);
+      return _wrap_new_vdouble2d_T__SWIG_1(self, argc, argv);
     }
   }
   if (argc == 2) {
@@ -12150,13 +12150,13 @@ SWIGINTERN PyObject *_wrap_new_vdouble2d_t(PyObject *self, PyObject *args) {
       int res = swig::asptr(argv[1], (std::vector< double,std::allocator< double > >**)(0));
       _v = SWIG_CheckState(res);
       if (_v) {
-        return _wrap_new_vdouble2d_t__SWIG_3(self, argc, argv);
+        return _wrap_new_vdouble2d_T__SWIG_3(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vdouble2d_t'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vdouble2d_T'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< double > >::vector()\n"
     "    std::vector< std::vector< double > >::vector(std::vector< std::vector< double,std::allocator< double > > > const &)\n"
@@ -12166,7 +12166,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_push_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_push_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::value_type *arg2 = 0 ;
@@ -12176,20 +12176,20 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_push_back(PyObject *self, PyObject *args)
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_t_push_back", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_T_push_back", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_push_back" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_push_back" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   {
     std::vector< double,std::allocator< double > > *ptr = (std::vector< double,std::allocator< double > > *)0;
     res2 = swig::asptr(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vdouble2d_t_push_back" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vdouble2d_T_push_back" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_t_push_back" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_T_push_back" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -12203,7 +12203,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_front(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_front(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -12216,7 +12216,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_front(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_front" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_front" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = (std::vector< std::vector< double > >::value_type *) &((std::vector< std::vector< double > > const *)arg1)->front();
@@ -12228,7 +12228,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -12241,7 +12241,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_back(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_back" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_back" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = (std::vector< std::vector< double > >::value_type *) &((std::vector< std::vector< double > > const *)arg1)->back();
@@ -12253,7 +12253,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_assign(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_assign(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::size_type arg2 ;
@@ -12266,25 +12266,25 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_assign(PyObject *self, PyObject *args) {
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_t_assign", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_T_assign", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_assign" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_assign" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_t_assign" "', argument " "2"" of type '" "std::vector< std::vector< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_T_assign" "', argument " "2"" of type '" "std::vector< std::vector< double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< double > >::size_type >(val2);
   {
     std::vector< double,std::allocator< double > > *ptr = (std::vector< double,std::allocator< double > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble2d_t_assign" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble2d_T_assign" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_t_assign" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_T_assign" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -12298,7 +12298,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::size_type arg2 ;
@@ -12313,22 +12313,22 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_resize__SWIG_1(PyObject *self, Py_ssize_t
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_resize" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_resize" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_t_resize" "', argument " "2"" of type '" "std::vector< std::vector< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_T_resize" "', argument " "2"" of type '" "std::vector< std::vector< double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< double > >::size_type >(val2);
   {
     std::vector< double,std::allocator< double > > *ptr = (std::vector< double,std::allocator< double > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble2d_t_resize" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble2d_T_resize" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_t_resize" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_T_resize" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -12342,13 +12342,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_resize(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_resize(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_t_resize", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_T_resize", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -12360,7 +12360,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_resize(PyObject *self, PyObject *args) {
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vdouble2d_t_resize__SWIG_0(self, argc, argv);
+        return _wrap_vdouble2d_T_resize__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -12377,14 +12377,14 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_resize(PyObject *self, PyObject *args) {
         int res = swig::asptr(argv[2], (std::vector< double,std::allocator< double > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vdouble2d_t_resize__SWIG_1(self, argc, argv);
+          return _wrap_vdouble2d_T_resize__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_t_resize'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_T_resize'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< double > >::resize(std::vector< std::vector< double > >::size_type)\n"
     "    std::vector< std::vector< double > >::resize(std::vector< std::vector< double > >::size_type,std::vector< std::vector< double > >::value_type const &)\n");
@@ -12392,7 +12392,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::iterator arg2 ;
@@ -12408,28 +12408,28 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_insert__SWIG_0(PyObject *self, Py_ssize_t
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_insert" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_insert" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t_insert" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T_insert" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t_insert" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T_insert" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
     }
   }
   {
     std::vector< double,std::allocator< double > > *ptr = (std::vector< double,std::allocator< double > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble2d_t_insert" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble2d_T_insert" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_t_insert" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_T_insert" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -12444,7 +12444,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::iterator arg2 ;
@@ -12462,33 +12462,33 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_insert__SWIG_1(PyObject *self, Py_ssize_t
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_insert" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_insert" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t_insert" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T_insert" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t_insert" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T_insert" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_size_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble2d_t_insert" "', argument " "3"" of type '" "std::vector< std::vector< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble2d_T_insert" "', argument " "3"" of type '" "std::vector< std::vector< double > >::size_type""'");
   } 
   arg3 = static_cast< std::vector< std::vector< double > >::size_type >(val3);
   {
     std::vector< double,std::allocator< double > > *ptr = (std::vector< double,std::allocator< double > > *)0;
     res4 = swig::asptr(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vdouble2d_t_insert" "', argument " "4"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vdouble2d_T_insert" "', argument " "4"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_t_insert" "', argument " "4"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_T_insert" "', argument " "4"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     arg4 = ptr;
   }
@@ -12502,13 +12502,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_insert(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_insert(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_t_insert", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_T_insert", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -12522,7 +12522,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_insert(PyObject *self, PyObject *args) {
         int res = swig::asptr(argv[2], (std::vector< double,std::allocator< double > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vdouble2d_t_insert__SWIG_0(self, argc, argv);
+          return _wrap_vdouble2d_T_insert__SWIG_0(self, argc, argv);
         }
       }
     }
@@ -12544,7 +12544,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_insert(PyObject *self, PyObject *args) {
           int res = swig::asptr(argv[3], (std::vector< double,std::allocator< double > >**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vdouble2d_t_insert__SWIG_1(self, argc, argv);
+            return _wrap_vdouble2d_T_insert__SWIG_1(self, argc, argv);
           }
         }
       }
@@ -12552,7 +12552,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_insert(PyObject *self, PyObject *args) {
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_t_insert'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_T_insert'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< double > >::insert(std::vector< std::vector< double > >::iterator,std::vector< std::vector< double > >::value_type const &)\n"
     "    std::vector< std::vector< double > >::insert(std::vector< std::vector< double > >::iterator,std::vector< std::vector< double > >::size_type,std::vector< std::vector< double > >::value_type const &)\n");
@@ -12560,7 +12560,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_reserve(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_reserve(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::size_type arg2 ;
@@ -12571,15 +12571,15 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_reserve(PyObject *self, PyObject *args) {
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_t_reserve", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_T_reserve", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_reserve" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_reserve" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_t_reserve" "', argument " "2"" of type '" "std::vector< std::vector< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_T_reserve" "', argument " "2"" of type '" "std::vector< std::vector< double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< double > >::size_type >(val2);
   (arg1)->reserve(arg2);
@@ -12590,7 +12590,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_capacity(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_capacity(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -12603,7 +12603,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_capacity(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_capacity" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_capacity" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = ((std::vector< std::vector< double > > const *)arg1)->capacity();
@@ -12614,7 +12614,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_delete_vdouble2d_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_delete_vdouble2d_T(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -12626,7 +12626,7 @@ SWIGINTERN PyObject *_wrap_delete_vdouble2d_t(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, SWIG_POINTER_DISOWN |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vdouble2d_t" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vdouble2d_T" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   {
@@ -12647,18 +12647,18 @@ fail:
 }
 
 
-SWIGINTERN PyObject *vdouble2d_t_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vdouble2d_T_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   PyObject *obj;
   if (!SWIG_Python_UnpackTuple(args, "swigregister", 1, 1, &obj)) return NULL;
   SWIG_TypeNewClientData(SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, SWIG_NewClientData(obj));
   return SWIG_Py_Void();
 }
 
-SWIGINTERN PyObject *vdouble2d_t_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vdouble2d_T_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   return SWIG_Python_InitShadowInstance(args);
 }
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_iterator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_iterator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   PyObject **arg2 = (PyObject **) 0 ;
@@ -12673,7 +12673,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_iterator(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_iterator" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_iterator" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = (swig::SwigPyIterator *)std_vector_Sl_int_Sg__iterator(arg1,arg2);
@@ -12684,7 +12684,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___nonzero__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___nonzero__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -12697,7 +12697,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___nonzero__(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___nonzero__" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___nonzero__" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = (bool)std_vector_Sl_int_Sg____nonzero__((std::vector< int > const *)arg1);
@@ -12708,7 +12708,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___bool__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___bool__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -12721,7 +12721,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___bool__(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___bool__" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___bool__" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = (bool)std_vector_Sl_int_Sg____bool__((std::vector< int > const *)arg1);
@@ -12732,7 +12732,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___len__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___len__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -12745,7 +12745,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___len__(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___len__" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___len__" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = std_vector_Sl_int_Sg____len__((std::vector< int > const *)arg1);
@@ -12756,7 +12756,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___getslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___getslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::difference_type arg2 ;
@@ -12771,20 +12771,20 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___getslice__(PyObject *self, PyObjec
   std::vector< int,std::allocator< int > > *result = 0 ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_integer_t___getslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_integer_T___getslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___getslice__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___getslice__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t___getslice__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T___getslice__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< int >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_t___getslice__" "', argument " "3"" of type '" "std::vector< int >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_T___getslice__" "', argument " "3"" of type '" "std::vector< int >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< int >::difference_type >(val3);
   try {
@@ -12801,7 +12801,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::difference_type arg2 ;
@@ -12817,17 +12817,17 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setslice____SWIG_0(PyObject *self,
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___setslice__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___setslice__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t___setslice__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T___setslice__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< int >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_t___setslice__" "', argument " "3"" of type '" "std::vector< int >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_T___setslice__" "', argument " "3"" of type '" "std::vector< int >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< int >::difference_type >(val3);
   try {
@@ -12844,7 +12844,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::difference_type arg2 ;
@@ -12862,27 +12862,27 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setslice____SWIG_1(PyObject *self,
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___setslice__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___setslice__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t___setslice__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T___setslice__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< int >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_t___setslice__" "', argument " "3"" of type '" "std::vector< int >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_T___setslice__" "', argument " "3"" of type '" "std::vector< int >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< int >::difference_type >(val3);
   {
     std::vector< int,std::allocator< int > > *ptr = (std::vector< int,std::allocator< int > > *)0;
     res4 = swig::asptr(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_integer_t___setslice__" "', argument " "4"" of type '" "std::vector< int,std::allocator< int > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_integer_T___setslice__" "', argument " "4"" of type '" "std::vector< int,std::allocator< int > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_integer_t___setslice__" "', argument " "4"" of type '" "std::vector< int,std::allocator< int > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_integer_T___setslice__" "', argument " "4"" of type '" "std::vector< int,std::allocator< int > > const &""'"); 
     }
     arg4 = ptr;
   }
@@ -12902,13 +12902,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___setslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___setslice__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_t___setslice__", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_T___setslice__", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -12925,7 +12925,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setslice__(PyObject *self, PyObjec
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_integer_t___setslice____SWIG_0(self, argc, argv);
+          return _wrap_vector_integer_T___setslice____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -12948,7 +12948,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setslice__(PyObject *self, PyObjec
           int res = swig::asptr(argv[3], (std::vector< int,std::allocator< int > >**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vector_integer_t___setslice____SWIG_1(self, argc, argv);
+            return _wrap_vector_integer_T___setslice____SWIG_1(self, argc, argv);
           }
         }
       }
@@ -12956,7 +12956,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setslice__(PyObject *self, PyObjec
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_t___setslice__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_T___setslice__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< int >::__setslice__(std::vector< int >::difference_type,std::vector< int >::difference_type)\n"
     "    std::vector< int >::__setslice__(std::vector< int >::difference_type,std::vector< int >::difference_type,std::vector< int,std::allocator< int > > const &)\n");
@@ -12964,7 +12964,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___delslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___delslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::difference_type arg2 ;
@@ -12978,20 +12978,20 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___delslice__(PyObject *self, PyObjec
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_integer_t___delslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_integer_T___delslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___delslice__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___delslice__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t___delslice__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T___delslice__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< int >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_t___delslice__" "', argument " "3"" of type '" "std::vector< int >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_T___delslice__" "', argument " "3"" of type '" "std::vector< int >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< int >::difference_type >(val3);
   try {
@@ -13008,7 +13008,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::difference_type arg2 ;
@@ -13021,12 +13021,12 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___delitem____SWIG_0(PyObject *self,
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___delitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___delitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t___delitem__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T___delitem__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< int >::difference_type >(val2);
   try {
@@ -13043,7 +13043,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -13055,12 +13055,12 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___getitem____SWIG_0(PyObject *self,
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___getitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___getitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -13078,7 +13078,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -13091,12 +13091,12 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setitem____SWIG_0(PyObject *self,
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___setitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___setitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -13104,10 +13104,10 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setitem____SWIG_0(PyObject *self,
     std::vector< int,std::allocator< int > > *ptr = (std::vector< int,std::allocator< int > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_integer_t___setitem__" "', argument " "3"" of type '" "std::vector< int,std::allocator< int > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_integer_T___setitem__" "', argument " "3"" of type '" "std::vector< int,std::allocator< int > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_integer_t___setitem__" "', argument " "3"" of type '" "std::vector< int,std::allocator< int > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_integer_T___setitem__" "', argument " "3"" of type '" "std::vector< int,std::allocator< int > > const &""'"); 
     }
     arg3 = ptr;
   }
@@ -13127,7 +13127,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -13138,12 +13138,12 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setitem____SWIG_1(PyObject *self,
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___setitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___setitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -13161,7 +13161,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -13172,12 +13172,12 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___delitem____SWIG_1(PyObject *self,
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___delitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___delitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -13195,13 +13195,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___delitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___delitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_t___delitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_T___delitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -13212,7 +13212,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___delitem__(PyObject *self, PyObject
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_integer_t___delitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_integer_T___delitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -13226,13 +13226,13 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___delitem__(PyObject *self, PyObject
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_integer_t___delitem____SWIG_0(self, argc, argv);
+        return _wrap_vector_integer_T___delitem____SWIG_0(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_t___delitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_T___delitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< int >::__delitem__(std::vector< int >::difference_type)\n"
     "    std::vector< int >::__delitem__(SWIGPY_SLICEOBJECT *)\n");
@@ -13240,7 +13240,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::difference_type arg2 ;
@@ -13254,12 +13254,12 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___getitem____SWIG_1(PyObject *self,
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___getitem__" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___getitem__" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t___getitem__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T___getitem__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< int >::difference_type >(val2);
   try {
@@ -13275,13 +13275,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___getitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___getitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_t___getitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_T___getitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -13292,7 +13292,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___getitem__(PyObject *self, PyObject
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_integer_t___getitem____SWIG_0(self, argc, argv);
+        return _wrap_vector_integer_T___getitem____SWIG_0(self, argc, argv);
       }
     }
   }
@@ -13306,13 +13306,13 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___getitem__(PyObject *self, PyObject
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_integer_t___getitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_integer_T___getitem____SWIG_1(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_t___getitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_T___getitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< int >::__getitem__(SWIGPY_SLICEOBJECT *)\n"
     "    std::vector< int >::__getitem__(std::vector< int >::difference_type) const\n");
@@ -13320,7 +13320,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::difference_type arg2 ;
@@ -13337,17 +13337,17 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setitem____SWIG_2(PyObject *self,
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___setitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___setitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t___setitem__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T___setitem__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< int >::difference_type >(val2);
   ecode3 = SWIG_AsVal_int(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_t___setitem__" "', argument " "3"" of type '" "std::vector< int >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_T___setitem__" "', argument " "3"" of type '" "std::vector< int >::value_type""'");
   } 
   temp3 = static_cast< std::vector< int >::value_type >(val3);
   arg3 = &temp3;
@@ -13363,13 +13363,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___setitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___setitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_t___setitem__", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_T___setitem__", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -13380,7 +13380,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setitem__(PyObject *self, PyObject
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_integer_t___setitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_integer_T___setitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -13396,7 +13396,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setitem__(PyObject *self, PyObject
         int res = swig::asptr(argv[2], (std::vector< int,std::allocator< int > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vector_integer_t___setitem____SWIG_0(self, argc, argv);
+          return _wrap_vector_integer_T___setitem____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -13416,14 +13416,14 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setitem__(PyObject *self, PyObject
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_integer_t___setitem____SWIG_2(self, argc, argv);
+          return _wrap_vector_integer_T___setitem____SWIG_2(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_t___setitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_T___setitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< int >::__setitem__(SWIGPY_SLICEOBJECT *,std::vector< int,std::allocator< int > > const &)\n"
     "    std::vector< int >::__setitem__(SWIGPY_SLICEOBJECT *)\n"
@@ -13432,7 +13432,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_pop(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_pop(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -13445,7 +13445,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_pop(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_pop" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_pop" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   try {
@@ -13460,7 +13460,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_append(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_append(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::value_type *arg2 = 0 ;
@@ -13472,15 +13472,15 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_append(PyObject *self, PyObject *arg
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_integer_t_append", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_integer_T_append", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_append" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_append" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_int(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t_append" "', argument " "2"" of type '" "std::vector< int >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T_append" "', argument " "2"" of type '" "std::vector< int >::value_type""'");
   } 
   temp2 = static_cast< std::vector< int >::value_type >(val2);
   arg2 = &temp2;
@@ -13492,7 +13492,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_integer_t__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
+SWIGINTERN PyObject *_wrap_new_vector_integer_T__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
   PyObject *resultobj = 0;
   std::vector< int > *result = 0 ;
   
@@ -13506,7 +13506,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_integer_t__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_integer_T__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = 0 ;
   int res1 = SWIG_OLDOBJ ;
@@ -13518,10 +13518,10 @@ SWIGINTERN PyObject *_wrap_new_vector_integer_t__SWIG_1(PyObject *self, Py_ssize
     std::vector< int,std::allocator< int > > *ptr = (std::vector< int,std::allocator< int > > *)0;
     res1 = swig::asptr(swig_obj[0], &ptr);
     if (!SWIG_IsOK(res1)) {
-      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vector_integer_t" "', argument " "1"" of type '" "std::vector< int > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vector_integer_T" "', argument " "1"" of type '" "std::vector< int > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_integer_t" "', argument " "1"" of type '" "std::vector< int > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_integer_T" "', argument " "1"" of type '" "std::vector< int > const &""'"); 
     }
     arg1 = ptr;
   }
@@ -13535,7 +13535,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_empty(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_empty(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -13548,7 +13548,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_empty(PyObject *self, PyObject *args
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_empty" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_empty" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = (bool)((std::vector< int > const *)arg1)->empty();
@@ -13559,7 +13559,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_size(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_size(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -13572,7 +13572,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_size(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_size" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_size" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = ((std::vector< int > const *)arg1)->size();
@@ -13583,7 +13583,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_swap(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_swap(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int > *arg2 = 0 ;
@@ -13594,18 +13594,18 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_swap(PyObject *self, PyObject *args)
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_integer_t_swap", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_integer_T_swap", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_swap" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_swap" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], &argp2, SWIGTYPE_p_std__vectorT_int_t,  0 );
   if (!SWIG_IsOK(res2)) {
-    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_integer_t_swap" "', argument " "2"" of type '" "std::vector< int > &""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_integer_T_swap" "', argument " "2"" of type '" "std::vector< int > &""'"); 
   }
   if (!argp2) {
-    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_integer_t_swap" "', argument " "2"" of type '" "std::vector< int > &""'"); 
+    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_integer_T_swap" "', argument " "2"" of type '" "std::vector< int > &""'"); 
   }
   arg2 = reinterpret_cast< std::vector< int > * >(argp2);
   (arg1)->swap(*arg2);
@@ -13616,7 +13616,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_begin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_begin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -13629,7 +13629,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_begin(PyObject *self, PyObject *args
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_begin" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_begin" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = (arg1)->begin();
@@ -13641,7 +13641,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_end(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_end(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -13654,7 +13654,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_end(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_end" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_end" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = (arg1)->end();
@@ -13666,7 +13666,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_rbegin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_rbegin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -13679,7 +13679,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_rbegin(PyObject *self, PyObject *arg
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_rbegin" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_rbegin" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = (arg1)->rbegin();
@@ -13691,7 +13691,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_rend(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_rend(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -13704,7 +13704,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_rend(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_rend" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_rend" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = (arg1)->rend();
@@ -13716,7 +13716,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_clear(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_clear(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -13728,7 +13728,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_clear(PyObject *self, PyObject *args
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_clear" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_clear" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   (arg1)->clear();
@@ -13739,7 +13739,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_get_allocator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_get_allocator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -13752,7 +13752,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_get_allocator(PyObject *self, PyObje
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_get_allocator" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_get_allocator" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = ((std::vector< int > const *)arg1)->get_allocator();
@@ -13763,7 +13763,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_integer_t__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_integer_T__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int >::size_type arg1 ;
   size_t val1 ;
@@ -13774,7 +13774,7 @@ SWIGINTERN PyObject *_wrap_new_vector_integer_t__SWIG_2(PyObject *self, Py_ssize
   if ((nobjs < 1) || (nobjs > 1)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_integer_t" "', argument " "1"" of type '" "std::vector< int >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_integer_T" "', argument " "1"" of type '" "std::vector< int >::size_type""'");
   } 
   arg1 = static_cast< std::vector< int >::size_type >(val1);
   result = (std::vector< int > *)new std::vector< int >(arg1);
@@ -13785,7 +13785,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_pop_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_pop_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -13797,7 +13797,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_pop_back(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_pop_back" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_pop_back" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   (arg1)->pop_back();
@@ -13808,7 +13808,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::size_type arg2 ;
@@ -13821,12 +13821,12 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_resize__SWIG_0(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_resize" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_resize" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t_resize" "', argument " "2"" of type '" "std::vector< int >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T_resize" "', argument " "2"" of type '" "std::vector< int >::size_type""'");
   } 
   arg2 = static_cast< std::vector< int >::size_type >(val2);
   (arg1)->resize(arg2);
@@ -13837,7 +13837,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::iterator arg2 ;
@@ -13851,18 +13851,18 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_erase__SWIG_0(PyObject *self, Py_ssi
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_erase" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_erase" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t_erase" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T_erase" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< int >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< int >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t_erase" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T_erase" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
     }
   }
   result = std_vector_Sl_int_Sg__erase__SWIG_0(arg1,SWIG_STD_MOVE(arg2));
@@ -13874,7 +13874,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::iterator arg2 ;
@@ -13891,29 +13891,29 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_erase__SWIG_1(PyObject *self, Py_ssi
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_erase" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_erase" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t_erase" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T_erase" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< int >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< int >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t_erase" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T_erase" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
     }
   }
   res3 = SWIG_ConvertPtr(swig_obj[2], SWIG_as_voidptrptr(&iter3), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res3) || !iter3) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t_erase" "', argument " "3"" of type '" "std::vector< int >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T_erase" "', argument " "3"" of type '" "std::vector< int >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< int >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< int >::iterator > *>(iter3);
     if (iter_t) {
       arg3 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t_erase" "', argument " "3"" of type '" "std::vector< int >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T_erase" "', argument " "3"" of type '" "std::vector< int >::iterator""'");
     }
   }
   result = std_vector_Sl_int_Sg__erase__SWIG_1(arg1,SWIG_STD_MOVE(arg2),SWIG_STD_MOVE(arg3));
@@ -13925,13 +13925,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_erase(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_erase(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_t_erase", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_T_erase", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -13942,7 +13942,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_erase(PyObject *self, PyObject *args
       int res = SWIG_ConvertPtr(argv[1], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
       _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< int >::iterator > *>(iter) != 0));
       if (_v) {
-        return _wrap_vector_integer_t_erase__SWIG_0(self, argc, argv);
+        return _wrap_vector_integer_T_erase__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -13959,14 +13959,14 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_erase(PyObject *self, PyObject *args
         int res = SWIG_ConvertPtr(argv[2], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
         _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< int >::iterator > *>(iter) != 0));
         if (_v) {
-          return _wrap_vector_integer_t_erase__SWIG_1(self, argc, argv);
+          return _wrap_vector_integer_T_erase__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_t_erase'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_T_erase'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< int >::erase(std::vector< int >::iterator)\n"
     "    std::vector< int >::erase(std::vector< int >::iterator,std::vector< int >::iterator)\n");
@@ -13974,7 +13974,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_integer_t__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_integer_T__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int >::size_type arg1 ;
   std::vector< int >::value_type *arg2 = 0 ;
@@ -13989,12 +13989,12 @@ SWIGINTERN PyObject *_wrap_new_vector_integer_t__SWIG_3(PyObject *self, Py_ssize
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_integer_t" "', argument " "1"" of type '" "std::vector< int >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_integer_T" "', argument " "1"" of type '" "std::vector< int >::size_type""'");
   } 
   arg1 = static_cast< std::vector< int >::size_type >(val1);
   ecode2 = SWIG_AsVal_int(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "new_vector_integer_t" "', argument " "2"" of type '" "std::vector< int >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "new_vector_integer_T" "', argument " "2"" of type '" "std::vector< int >::value_type""'");
   } 
   temp2 = static_cast< std::vector< int >::value_type >(val2);
   arg2 = &temp2;
@@ -14006,16 +14006,16 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_integer_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_new_vector_integer_T(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vector_integer_t", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vector_integer_T", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 0) {
-    return _wrap_new_vector_integer_t__SWIG_0(self, argc, argv);
+    return _wrap_new_vector_integer_T__SWIG_0(self, argc, argv);
   }
   if (argc == 1) {
     int _v = 0;
@@ -14024,7 +14024,7 @@ SWIGINTERN PyObject *_wrap_new_vector_integer_t(PyObject *self, PyObject *args)
       _v = SWIG_CheckState(res);
     }
     if (_v) {
-      return _wrap_new_vector_integer_t__SWIG_2(self, argc, argv);
+      return _wrap_new_vector_integer_T__SWIG_2(self, argc, argv);
     }
   }
   if (argc == 1) {
@@ -14032,7 +14032,7 @@ SWIGINTERN PyObject *_wrap_new_vector_integer_t(PyObject *self, PyObject *args)
     int res = swig::asptr(argv[0], (std::vector< int,std::allocator< int > >**)(0));
     _v = SWIG_CheckState(res);
     if (_v) {
-      return _wrap_new_vector_integer_t__SWIG_1(self, argc, argv);
+      return _wrap_new_vector_integer_T__SWIG_1(self, argc, argv);
     }
   }
   if (argc == 2) {
@@ -14047,13 +14047,13 @@ SWIGINTERN PyObject *_wrap_new_vector_integer_t(PyObject *self, PyObject *args)
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_new_vector_integer_t__SWIG_3(self, argc, argv);
+        return _wrap_new_vector_integer_T__SWIG_3(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vector_integer_t'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vector_integer_T'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< int >::vector()\n"
     "    std::vector< int >::vector(std::vector< int > const &)\n"
@@ -14063,7 +14063,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_push_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_push_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::value_type *arg2 = 0 ;
@@ -14075,15 +14075,15 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_push_back(PyObject *self, PyObject *
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_integer_t_push_back", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_integer_T_push_back", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_push_back" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_push_back" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_int(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t_push_back" "', argument " "2"" of type '" "std::vector< int >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T_push_back" "', argument " "2"" of type '" "std::vector< int >::value_type""'");
   } 
   temp2 = static_cast< std::vector< int >::value_type >(val2);
   arg2 = &temp2;
@@ -14095,7 +14095,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_front(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_front(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -14108,7 +14108,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_front(PyObject *self, PyObject *args
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_front" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_front" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = (std::vector< int >::value_type *) &((std::vector< int > const *)arg1)->front();
@@ -14120,7 +14120,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -14133,7 +14133,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_back(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_back" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_back" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = (std::vector< int >::value_type *) &((std::vector< int > const *)arg1)->back();
@@ -14145,7 +14145,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_assign(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_assign(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::size_type arg2 ;
@@ -14160,20 +14160,20 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_assign(PyObject *self, PyObject *arg
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_integer_t_assign", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_integer_T_assign", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_assign" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_assign" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t_assign" "', argument " "2"" of type '" "std::vector< int >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T_assign" "', argument " "2"" of type '" "std::vector< int >::size_type""'");
   } 
   arg2 = static_cast< std::vector< int >::size_type >(val2);
   ecode3 = SWIG_AsVal_int(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_t_assign" "', argument " "3"" of type '" "std::vector< int >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_T_assign" "', argument " "3"" of type '" "std::vector< int >::value_type""'");
   } 
   temp3 = static_cast< std::vector< int >::value_type >(val3);
   arg3 = &temp3;
@@ -14185,7 +14185,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::size_type arg2 ;
@@ -14202,17 +14202,17 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_resize__SWIG_1(PyObject *self, Py_ss
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_resize" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_resize" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t_resize" "', argument " "2"" of type '" "std::vector< int >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T_resize" "', argument " "2"" of type '" "std::vector< int >::size_type""'");
   } 
   arg2 = static_cast< std::vector< int >::size_type >(val2);
   ecode3 = SWIG_AsVal_int(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_t_resize" "', argument " "3"" of type '" "std::vector< int >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_T_resize" "', argument " "3"" of type '" "std::vector< int >::value_type""'");
   } 
   temp3 = static_cast< std::vector< int >::value_type >(val3);
   arg3 = &temp3;
@@ -14224,13 +14224,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_resize(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_resize(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_t_resize", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_T_resize", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -14242,7 +14242,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_resize(PyObject *self, PyObject *arg
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_integer_t_resize__SWIG_0(self, argc, argv);
+        return _wrap_vector_integer_T_resize__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -14261,14 +14261,14 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_resize(PyObject *self, PyObject *arg
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_integer_t_resize__SWIG_1(self, argc, argv);
+          return _wrap_vector_integer_T_resize__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_t_resize'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_T_resize'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< int >::resize(std::vector< int >::size_type)\n"
     "    std::vector< int >::resize(std::vector< int >::size_type,std::vector< int >::value_type const &)\n");
@@ -14276,7 +14276,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::iterator arg2 ;
@@ -14294,23 +14294,23 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_insert__SWIG_0(PyObject *self, Py_ss
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_insert" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_insert" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t_insert" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T_insert" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< int >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< int >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t_insert" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T_insert" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_int(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_t_insert" "', argument " "3"" of type '" "std::vector< int >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_T_insert" "', argument " "3"" of type '" "std::vector< int >::value_type""'");
   } 
   temp3 = static_cast< std::vector< int >::value_type >(val3);
   arg3 = &temp3;
@@ -14323,7 +14323,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::iterator arg2 ;
@@ -14343,28 +14343,28 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_insert__SWIG_1(PyObject *self, Py_ss
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_insert" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_insert" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t_insert" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T_insert" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< int >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< int >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t_insert" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T_insert" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_size_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_t_insert" "', argument " "3"" of type '" "std::vector< int >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_T_insert" "', argument " "3"" of type '" "std::vector< int >::size_type""'");
   } 
   arg3 = static_cast< std::vector< int >::size_type >(val3);
   ecode4 = SWIG_AsVal_int(swig_obj[3], &val4);
   if (!SWIG_IsOK(ecode4)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode4), "in method '" "vector_integer_t_insert" "', argument " "4"" of type '" "std::vector< int >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode4), "in method '" "vector_integer_T_insert" "', argument " "4"" of type '" "std::vector< int >::value_type""'");
   } 
   temp4 = static_cast< std::vector< int >::value_type >(val4);
   arg4 = &temp4;
@@ -14376,13 +14376,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_insert(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_insert(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_t_insert", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_T_insert", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -14398,7 +14398,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_insert(PyObject *self, PyObject *arg
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_integer_t_insert__SWIG_0(self, argc, argv);
+          return _wrap_vector_integer_T_insert__SWIG_0(self, argc, argv);
         }
       }
     }
@@ -14422,7 +14422,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_insert(PyObject *self, PyObject *arg
             _v = SWIG_CheckState(res);
           }
           if (_v) {
-            return _wrap_vector_integer_t_insert__SWIG_1(self, argc, argv);
+            return _wrap_vector_integer_T_insert__SWIG_1(self, argc, argv);
           }
         }
       }
@@ -14430,7 +14430,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_insert(PyObject *self, PyObject *arg
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_t_insert'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_T_insert'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< int >::insert(std::vector< int >::iterator,std::vector< int >::value_type const &)\n"
     "    std::vector< int >::insert(std::vector< int >::iterator,std::vector< int >::size_type,std::vector< int >::value_type const &)\n");
@@ -14438,7 +14438,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_reserve(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_reserve(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::size_type arg2 ;
@@ -14449,15 +14449,15 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_reserve(PyObject *self, PyObject *ar
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_integer_t_reserve", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_integer_T_reserve", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_reserve" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_reserve" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t_reserve" "', argument " "2"" of type '" "std::vector< int >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T_reserve" "', argument " "2"" of type '" "std::vector< int >::size_type""'");
   } 
   arg2 = static_cast< std::vector< int >::size_type >(val2);
   (arg1)->reserve(arg2);
@@ -14468,7 +14468,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_capacity(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_capacity(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -14481,7 +14481,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_capacity(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_capacity" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_capacity" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = ((std::vector< int > const *)arg1)->capacity();
@@ -14492,7 +14492,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_delete_vector_integer_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_delete_vector_integer_T(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -14504,7 +14504,7 @@ SWIGINTERN PyObject *_wrap_delete_vector_integer_t(PyObject *self, PyObject *arg
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, SWIG_POINTER_DISOWN |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vector_integer_t" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vector_integer_T" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   {
@@ -14525,18 +14525,18 @@ fail:
 }
 
 
-SWIGINTERN PyObject *vector_integer_t_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vector_integer_T_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   PyObject *obj;
   if (!SWIG_Python_UnpackTuple(args, "swigregister", 1, 1, &obj)) return NULL;
   SWIG_TypeNewClientData(SWIGTYPE_p_std__vectorT_int_t, SWIG_NewClientData(obj));
   return SWIG_Py_Void();
 }
 
-SWIGINTERN PyObject *vector_integer_t_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vector_integer_T_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   return SWIG_Python_InitShadowInstance(args);
 }
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_iterator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_iterator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   PyObject **arg2 = (PyObject **) 0 ;
@@ -14551,7 +14551,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_iterator(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_iterator" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_iterator" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = (swig::SwigPyIterator *)std_vector_Sl_std_vector_Sl_int_Sg__Sg__iterator(arg1,arg2);
@@ -14562,7 +14562,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___nonzero__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___nonzero__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -14575,7 +14575,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___nonzero__(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___nonzero__" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___nonzero__" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = (bool)std_vector_Sl_std_vector_Sl_int_Sg__Sg____nonzero__((std::vector< std::vector< int > > const *)arg1);
@@ -14586,7 +14586,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___bool__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___bool__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -14599,7 +14599,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___bool__(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___bool__" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___bool__" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = (bool)std_vector_Sl_std_vector_Sl_int_Sg__Sg____bool__((std::vector< std::vector< int > > const *)arg1);
@@ -14610,7 +14610,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___len__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___len__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -14623,7 +14623,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___len__(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___len__" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___len__" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = std_vector_Sl_std_vector_Sl_int_Sg__Sg____len__((std::vector< std::vector< int > > const *)arg1);
@@ -14634,7 +14634,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___getslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___getslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::difference_type arg2 ;
@@ -14649,20 +14649,20 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___getslice__(PyObject *self, PyObject *a
   std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > *result = 0 ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_t___getslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_T___getslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___getslice__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___getslice__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_t___getslice__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_T___getslice__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< int > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vinteger2d_t___getslice__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vinteger2d_T___getslice__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::vector< int > >::difference_type >(val3);
   try {
@@ -14679,7 +14679,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::difference_type arg2 ;
@@ -14695,17 +14695,17 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setslice____SWIG_0(PyObject *self, Py_
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___setslice__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___setslice__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_t___setslice__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_T___setslice__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< int > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vinteger2d_t___setslice__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vinteger2d_T___setslice__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::vector< int > >::difference_type >(val3);
   try {
@@ -14722,7 +14722,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::difference_type arg2 ;
@@ -14740,27 +14740,27 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setslice____SWIG_1(PyObject *self, Py_
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___setslice__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___setslice__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_t___setslice__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_T___setslice__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< int > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vinteger2d_t___setslice__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vinteger2d_T___setslice__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::vector< int > >::difference_type >(val3);
   {
     std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > *ptr = (std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > *)0;
     res4 = swig::asptr(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vinteger2d_t___setslice__" "', argument " "4"" of type '" "std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vinteger2d_T___setslice__" "', argument " "4"" of type '" "std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_t___setslice__" "', argument " "4"" of type '" "std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_T___setslice__" "', argument " "4"" of type '" "std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > const &""'"); 
     }
     arg4 = ptr;
   }
@@ -14780,13 +14780,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___setslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___setslice__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_t___setslice__", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_T___setslice__", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -14803,7 +14803,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setslice__(PyObject *self, PyObject *a
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vinteger2d_t___setslice____SWIG_0(self, argc, argv);
+          return _wrap_vinteger2d_T___setslice____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -14826,7 +14826,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setslice__(PyObject *self, PyObject *a
           int res = swig::asptr(argv[3], (std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > >**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vinteger2d_t___setslice____SWIG_1(self, argc, argv);
+            return _wrap_vinteger2d_T___setslice____SWIG_1(self, argc, argv);
           }
         }
       }
@@ -14834,7 +14834,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setslice__(PyObject *self, PyObject *a
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_t___setslice__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_T___setslice__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< int > >::__setslice__(std::vector< std::vector< int > >::difference_type,std::vector< std::vector< int > >::difference_type)\n"
     "    std::vector< std::vector< int > >::__setslice__(std::vector< std::vector< int > >::difference_type,std::vector< std::vector< int > >::difference_type,std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > const &)\n");
@@ -14842,7 +14842,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___delslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___delslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::difference_type arg2 ;
@@ -14856,20 +14856,20 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___delslice__(PyObject *self, PyObject *a
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_t___delslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_T___delslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___delslice__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___delslice__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_t___delslice__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_T___delslice__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< int > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vinteger2d_t___delslice__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vinteger2d_T___delslice__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::vector< int > >::difference_type >(val3);
   try {
@@ -14886,7 +14886,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::difference_type arg2 ;
@@ -14899,12 +14899,12 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___delitem____SWIG_0(PyObject *self, Py_s
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___delitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___delitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_t___delitem__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_T___delitem__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< int > >::difference_type >(val2);
   try {
@@ -14921,7 +14921,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -14933,12 +14933,12 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___getitem____SWIG_0(PyObject *self, Py_s
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___getitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___getitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -14956,7 +14956,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -14969,12 +14969,12 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setitem____SWIG_0(PyObject *self, Py_s
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -14982,10 +14982,10 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setitem____SWIG_0(PyObject *self, Py_s
     std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > *ptr = (std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vinteger2d_t___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vinteger2d_T___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_t___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_T___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > const &""'"); 
     }
     arg3 = ptr;
   }
@@ -15005,7 +15005,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -15016,12 +15016,12 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setitem____SWIG_1(PyObject *self, Py_s
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -15039,7 +15039,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -15050,12 +15050,12 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___delitem____SWIG_1(PyObject *self, Py_s
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___delitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___delitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -15073,13 +15073,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___delitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___delitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_t___delitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_T___delitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -15090,7 +15090,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___delitem__(PyObject *self, PyObject *ar
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vinteger2d_t___delitem____SWIG_1(self, argc, argv);
+        return _wrap_vinteger2d_T___delitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -15104,13 +15104,13 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___delitem__(PyObject *self, PyObject *ar
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vinteger2d_t___delitem____SWIG_0(self, argc, argv);
+        return _wrap_vinteger2d_T___delitem____SWIG_0(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_t___delitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_T___delitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< int > >::__delitem__(std::vector< std::vector< int > >::difference_type)\n"
     "    std::vector< std::vector< int > >::__delitem__(SWIGPY_SLICEOBJECT *)\n");
@@ -15118,7 +15118,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::difference_type arg2 ;
@@ -15132,12 +15132,12 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___getitem____SWIG_1(PyObject *self, Py_s
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___getitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___getitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_t___getitem__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_T___getitem__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< int > >::difference_type >(val2);
   try {
@@ -15153,13 +15153,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___getitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___getitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_t___getitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_T___getitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -15170,7 +15170,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___getitem__(PyObject *self, PyObject *ar
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vinteger2d_t___getitem____SWIG_0(self, argc, argv);
+        return _wrap_vinteger2d_T___getitem____SWIG_0(self, argc, argv);
       }
     }
   }
@@ -15184,13 +15184,13 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___getitem__(PyObject *self, PyObject *ar
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vinteger2d_t___getitem____SWIG_1(self, argc, argv);
+        return _wrap_vinteger2d_T___getitem____SWIG_1(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_t___getitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_T___getitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< int > >::__getitem__(SWIGPY_SLICEOBJECT *)\n"
     "    std::vector< std::vector< int > >::__getitem__(std::vector< std::vector< int > >::difference_type) const\n");
@@ -15198,7 +15198,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::difference_type arg2 ;
@@ -15213,22 +15213,22 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setitem____SWIG_2(PyObject *self, Py_s
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_t___setitem__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_T___setitem__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< int > >::difference_type >(val2);
   {
     std::vector< int,std::allocator< int > > *ptr = (std::vector< int,std::allocator< int > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vinteger2d_t___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vinteger2d_T___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_t___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_T___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -15246,13 +15246,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___setitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___setitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_t___setitem__", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_T___setitem__", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -15263,7 +15263,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setitem__(PyObject *self, PyObject *ar
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vinteger2d_t___setitem____SWIG_1(self, argc, argv);
+        return _wrap_vinteger2d_T___setitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -15279,7 +15279,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setitem__(PyObject *self, PyObject *ar
         int res = swig::asptr(argv[2], (std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vinteger2d_t___setitem____SWIG_0(self, argc, argv);
+          return _wrap_vinteger2d_T___setitem____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -15297,14 +15297,14 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setitem__(PyObject *self, PyObject *ar
         int res = swig::asptr(argv[2], (std::vector< int,std::allocator< int > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vinteger2d_t___setitem____SWIG_2(self, argc, argv);
+          return _wrap_vinteger2d_T___setitem____SWIG_2(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_t___setitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_T___setitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< int > >::__setitem__(SWIGPY_SLICEOBJECT *,std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > const &)\n"
     "    std::vector< std::vector< int > >::__setitem__(SWIGPY_SLICEOBJECT *)\n"
@@ -15313,7 +15313,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_pop(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_pop(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -15326,7 +15326,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_pop(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_pop" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_pop" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   try {
@@ -15341,7 +15341,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_append(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_append(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::value_type *arg2 = 0 ;
@@ -15351,20 +15351,20 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_append(PyObject *self, PyObject *args) {
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_t_append", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_T_append", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_append" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_append" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   {
     std::vector< int,std::allocator< int > > *ptr = (std::vector< int,std::allocator< int > > *)0;
     res2 = swig::asptr(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vinteger2d_t_append" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vinteger2d_T_append" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_t_append" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_T_append" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -15378,7 +15378,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vinteger2d_t__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
+SWIGINTERN PyObject *_wrap_new_vinteger2d_T__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *result = 0 ;
   
@@ -15392,7 +15392,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vinteger2d_t__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vinteger2d_T__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int,std::allocator< int > > > *arg1 = 0 ;
   int res1 = SWIG_OLDOBJ ;
@@ -15404,10 +15404,10 @@ SWIGINTERN PyObject *_wrap_new_vinteger2d_t__SWIG_1(PyObject *self, Py_ssize_t n
     std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > *ptr = (std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > *)0;
     res1 = swig::asptr(swig_obj[0], &ptr);
     if (!SWIG_IsOK(res1)) {
-      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vinteger2d_t" "', argument " "1"" of type '" "std::vector< std::vector< int,std::allocator< int > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vinteger2d_T" "', argument " "1"" of type '" "std::vector< std::vector< int,std::allocator< int > > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vinteger2d_t" "', argument " "1"" of type '" "std::vector< std::vector< int,std::allocator< int > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vinteger2d_T" "', argument " "1"" of type '" "std::vector< std::vector< int,std::allocator< int > > > const &""'"); 
     }
     arg1 = ptr;
   }
@@ -15421,7 +15421,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_empty(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_empty(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -15434,7 +15434,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_empty(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_empty" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_empty" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = (bool)((std::vector< std::vector< int > > const *)arg1)->empty();
@@ -15445,7 +15445,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_size(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_size(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -15458,7 +15458,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_size(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_size" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_size" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = ((std::vector< std::vector< int > > const *)arg1)->size();
@@ -15469,7 +15469,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_swap(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_swap(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int,std::allocator< int > > > *arg2 = 0 ;
@@ -15480,18 +15480,18 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_swap(PyObject *self, PyObject *args) {
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_t_swap", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_T_swap", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_swap" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_swap" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], &argp2, SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t,  0 );
   if (!SWIG_IsOK(res2)) {
-    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vinteger2d_t_swap" "', argument " "2"" of type '" "std::vector< std::vector< int,std::allocator< int > > > &""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vinteger2d_T_swap" "', argument " "2"" of type '" "std::vector< std::vector< int,std::allocator< int > > > &""'"); 
   }
   if (!argp2) {
-    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_t_swap" "', argument " "2"" of type '" "std::vector< std::vector< int,std::allocator< int > > > &""'"); 
+    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_T_swap" "', argument " "2"" of type '" "std::vector< std::vector< int,std::allocator< int > > > &""'"); 
   }
   arg2 = reinterpret_cast< std::vector< std::vector< int,std::allocator< int > > > * >(argp2);
   (arg1)->swap(*arg2);
@@ -15502,7 +15502,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_begin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_begin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -15515,7 +15515,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_begin(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_begin" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_begin" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = (arg1)->begin();
@@ -15527,7 +15527,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_end(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_end(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -15540,7 +15540,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_end(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_end" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_end" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = (arg1)->end();
@@ -15552,7 +15552,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_rbegin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_rbegin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -15565,7 +15565,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_rbegin(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_rbegin" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_rbegin" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = (arg1)->rbegin();
@@ -15577,7 +15577,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_rend(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_rend(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -15590,7 +15590,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_rend(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_rend" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_rend" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = (arg1)->rend();
@@ -15602,7 +15602,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_clear(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_clear(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -15614,7 +15614,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_clear(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_clear" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_clear" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   (arg1)->clear();
@@ -15625,7 +15625,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_get_allocator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_get_allocator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -15638,7 +15638,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_get_allocator(PyObject *self, PyObject *
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_get_allocator" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_get_allocator" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = ((std::vector< std::vector< int > > const *)arg1)->get_allocator();
@@ -15649,7 +15649,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vinteger2d_t__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vinteger2d_T__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > >::size_type arg1 ;
   size_t val1 ;
@@ -15660,7 +15660,7 @@ SWIGINTERN PyObject *_wrap_new_vinteger2d_t__SWIG_2(PyObject *self, Py_ssize_t n
   if ((nobjs < 1) || (nobjs > 1)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vinteger2d_t" "', argument " "1"" of type '" "std::vector< std::vector< int > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vinteger2d_T" "', argument " "1"" of type '" "std::vector< std::vector< int > >::size_type""'");
   } 
   arg1 = static_cast< std::vector< std::vector< int > >::size_type >(val1);
   result = (std::vector< std::vector< int > > *)new std::vector< std::vector< int > >(arg1);
@@ -15671,7 +15671,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_pop_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_pop_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -15683,7 +15683,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_pop_back(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_pop_back" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_pop_back" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   (arg1)->pop_back();
@@ -15694,7 +15694,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::size_type arg2 ;
@@ -15707,12 +15707,12 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_resize__SWIG_0(PyObject *self, Py_ssize_
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_resize" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_resize" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_t_resize" "', argument " "2"" of type '" "std::vector< std::vector< int > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_T_resize" "', argument " "2"" of type '" "std::vector< std::vector< int > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< int > >::size_type >(val2);
   (arg1)->resize(arg2);
@@ -15723,7 +15723,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::iterator arg2 ;
@@ -15737,18 +15737,18 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_erase__SWIG_0(PyObject *self, Py_ssize_t
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_erase" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_erase" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t_erase" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T_erase" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t_erase" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T_erase" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
     }
   }
   result = std_vector_Sl_std_vector_Sl_int_Sg__Sg__erase__SWIG_0(arg1,SWIG_STD_MOVE(arg2));
@@ -15760,7 +15760,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::iterator arg2 ;
@@ -15777,29 +15777,29 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_erase__SWIG_1(PyObject *self, Py_ssize_t
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_erase" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_erase" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t_erase" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T_erase" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t_erase" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T_erase" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
     }
   }
   res3 = SWIG_ConvertPtr(swig_obj[2], SWIG_as_voidptrptr(&iter3), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res3) || !iter3) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t_erase" "', argument " "3"" of type '" "std::vector< std::vector< int > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T_erase" "', argument " "3"" of type '" "std::vector< std::vector< int > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *>(iter3);
     if (iter_t) {
       arg3 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t_erase" "', argument " "3"" of type '" "std::vector< std::vector< int > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T_erase" "', argument " "3"" of type '" "std::vector< std::vector< int > >::iterator""'");
     }
   }
   result = std_vector_Sl_std_vector_Sl_int_Sg__Sg__erase__SWIG_1(arg1,SWIG_STD_MOVE(arg2),SWIG_STD_MOVE(arg3));
@@ -15811,13 +15811,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_erase(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_erase(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_t_erase", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_T_erase", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -15828,7 +15828,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_erase(PyObject *self, PyObject *args) {
       int res = SWIG_ConvertPtr(argv[1], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
       _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *>(iter) != 0));
       if (_v) {
-        return _wrap_vinteger2d_t_erase__SWIG_0(self, argc, argv);
+        return _wrap_vinteger2d_T_erase__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -15845,14 +15845,14 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_erase(PyObject *self, PyObject *args) {
         int res = SWIG_ConvertPtr(argv[2], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
         _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *>(iter) != 0));
         if (_v) {
-          return _wrap_vinteger2d_t_erase__SWIG_1(self, argc, argv);
+          return _wrap_vinteger2d_T_erase__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_t_erase'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_T_erase'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< int > >::erase(std::vector< std::vector< int > >::iterator)\n"
     "    std::vector< std::vector< int > >::erase(std::vector< std::vector< int > >::iterator,std::vector< std::vector< int > >::iterator)\n");
@@ -15860,7 +15860,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vinteger2d_t__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vinteger2d_T__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > >::size_type arg1 ;
   std::vector< std::vector< int > >::value_type *arg2 = 0 ;
@@ -15873,17 +15873,17 @@ SWIGINTERN PyObject *_wrap_new_vinteger2d_t__SWIG_3(PyObject *self, Py_ssize_t n
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vinteger2d_t" "', argument " "1"" of type '" "std::vector< std::vector< int > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vinteger2d_T" "', argument " "1"" of type '" "std::vector< std::vector< int > >::size_type""'");
   } 
   arg1 = static_cast< std::vector< std::vector< int > >::size_type >(val1);
   {
     std::vector< int,std::allocator< int > > *ptr = (std::vector< int,std::allocator< int > > *)0;
     res2 = swig::asptr(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "new_vinteger2d_t" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "new_vinteger2d_T" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vinteger2d_t" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vinteger2d_T" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -15897,16 +15897,16 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vinteger2d_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_new_vinteger2d_T(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vinteger2d_t", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vinteger2d_T", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 0) {
-    return _wrap_new_vinteger2d_t__SWIG_0(self, argc, argv);
+    return _wrap_new_vinteger2d_T__SWIG_0(self, argc, argv);
   }
   if (argc == 1) {
     int _v = 0;
@@ -15915,7 +15915,7 @@ SWIGINTERN PyObject *_wrap_new_vinteger2d_t(PyObject *self, PyObject *args) {
       _v = SWIG_CheckState(res);
     }
     if (_v) {
-      return _wrap_new_vinteger2d_t__SWIG_2(self, argc, argv);
+      return _wrap_new_vinteger2d_T__SWIG_2(self, argc, argv);
     }
   }
   if (argc == 1) {
@@ -15923,7 +15923,7 @@ SWIGINTERN PyObject *_wrap_new_vinteger2d_t(PyObject *self, PyObject *args) {
     int res = swig::asptr(argv[0], (std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > >**)(0));
     _v = SWIG_CheckState(res);
     if (_v) {
-      return _wrap_new_vinteger2d_t__SWIG_1(self, argc, argv);
+      return _wrap_new_vinteger2d_T__SWIG_1(self, argc, argv);
     }
   }
   if (argc == 2) {
@@ -15936,13 +15936,13 @@ SWIGINTERN PyObject *_wrap_new_vinteger2d_t(PyObject *self, PyObject *args) {
       int res = swig::asptr(argv[1], (std::vector< int,std::allocator< int > >**)(0));
       _v = SWIG_CheckState(res);
       if (_v) {
-        return _wrap_new_vinteger2d_t__SWIG_3(self, argc, argv);
+        return _wrap_new_vinteger2d_T__SWIG_3(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vinteger2d_t'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vinteger2d_T'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< int > >::vector()\n"
     "    std::vector< std::vector< int > >::vector(std::vector< std::vector< int,std::allocator< int > > > const &)\n"
@@ -15952,7 +15952,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_push_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_push_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::value_type *arg2 = 0 ;
@@ -15962,20 +15962,20 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_push_back(PyObject *self, PyObject *args
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_t_push_back", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_T_push_back", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_push_back" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_push_back" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   {
     std::vector< int,std::allocator< int > > *ptr = (std::vector< int,std::allocator< int > > *)0;
     res2 = swig::asptr(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vinteger2d_t_push_back" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vinteger2d_T_push_back" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_t_push_back" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_T_push_back" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -15989,7 +15989,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_front(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_front(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -16002,7 +16002,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_front(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_front" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_front" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = (std::vector< std::vector< int > >::value_type *) &((std::vector< std::vector< int > > const *)arg1)->front();
@@ -16014,7 +16014,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -16027,7 +16027,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_back(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_back" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_back" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = (std::vector< std::vector< int > >::value_type *) &((std::vector< std::vector< int > > const *)arg1)->back();
@@ -16039,7 +16039,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_assign(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_assign(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::size_type arg2 ;
@@ -16052,25 +16052,25 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_assign(PyObject *self, PyObject *args) {
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_t_assign", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_T_assign", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_assign" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_assign" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_t_assign" "', argument " "2"" of type '" "std::vector< std::vector< int > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_T_assign" "', argument " "2"" of type '" "std::vector< std::vector< int > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< int > >::size_type >(val2);
   {
     std::vector< int,std::allocator< int > > *ptr = (std::vector< int,std::allocator< int > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vinteger2d_t_assign" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vinteger2d_T_assign" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_t_assign" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_T_assign" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -16084,7 +16084,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::size_type arg2 ;
@@ -16099,22 +16099,22 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_resize__SWIG_1(PyObject *self, Py_ssize_
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_resize" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_resize" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_t_resize" "', argument " "2"" of type '" "std::vector< std::vector< int > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_T_resize" "', argument " "2"" of type '" "std::vector< std::vector< int > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< int > >::size_type >(val2);
   {
     std::vector< int,std::allocator< int > > *ptr = (std::vector< int,std::allocator< int > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vinteger2d_t_resize" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vinteger2d_T_resize" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_t_resize" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_T_resize" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -16128,13 +16128,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_resize(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_resize(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_t_resize", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_T_resize", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -16146,7 +16146,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_resize(PyObject *self, PyObject *args) {
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vinteger2d_t_resize__SWIG_0(self, argc, argv);
+        return _wrap_vinteger2d_T_resize__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -16163,14 +16163,14 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_resize(PyObject *self, PyObject *args) {
         int res = swig::asptr(argv[2], (std::vector< int,std::allocator< int > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vinteger2d_t_resize__SWIG_1(self, argc, argv);
+          return _wrap_vinteger2d_T_resize__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_t_resize'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_T_resize'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< int > >::resize(std::vector< std::vector< int > >::size_type)\n"
     "    std::vector< std::vector< int > >::resize(std::vector< std::vector< int > >::size_type,std::vector< std::vector< int > >::value_type const &)\n");
@@ -16178,7 +16178,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::iterator arg2 ;
@@ -16194,28 +16194,28 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_insert__SWIG_0(PyObject *self, Py_ssize_
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_insert" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_insert" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t_insert" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T_insert" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t_insert" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T_insert" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
     }
   }
   {
     std::vector< int,std::allocator< int > > *ptr = (std::vector< int,std::allocator< int > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vinteger2d_t_insert" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vinteger2d_T_insert" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_t_insert" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_T_insert" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -16230,7 +16230,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::iterator arg2 ;
@@ -16248,33 +16248,33 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_insert__SWIG_1(PyObject *self, Py_ssize_
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_insert" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_insert" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t_insert" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T_insert" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t_insert" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T_insert" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_size_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vinteger2d_t_insert" "', argument " "3"" of type '" "std::vector< std::vector< int > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vinteger2d_T_insert" "', argument " "3"" of type '" "std::vector< std::vector< int > >::size_type""'");
   } 
   arg3 = static_cast< std::vector< std::vector< int > >::size_type >(val3);
   {
     std::vector< int,std::allocator< int > > *ptr = (std::vector< int,std::allocator< int > > *)0;
     res4 = swig::asptr(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vinteger2d_t_insert" "', argument " "4"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vinteger2d_T_insert" "', argument " "4"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_t_insert" "', argument " "4"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_T_insert" "', argument " "4"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     arg4 = ptr;
   }
@@ -16288,13 +16288,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_insert(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_insert(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_t_insert", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_T_insert", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -16308,7 +16308,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_insert(PyObject *self, PyObject *args) {
         int res = swig::asptr(argv[2], (std::vector< int,std::allocator< int > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vinteger2d_t_insert__SWIG_0(self, argc, argv);
+          return _wrap_vinteger2d_T_insert__SWIG_0(self, argc, argv);
         }
       }
     }
@@ -16330,7 +16330,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_insert(PyObject *self, PyObject *args) {
           int res = swig::asptr(argv[3], (std::vector< int,std::allocator< int > >**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vinteger2d_t_insert__SWIG_1(self, argc, argv);
+            return _wrap_vinteger2d_T_insert__SWIG_1(self, argc, argv);
           }
         }
       }
@@ -16338,7 +16338,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_insert(PyObject *self, PyObject *args) {
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_t_insert'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_T_insert'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< int > >::insert(std::vector< std::vector< int > >::iterator,std::vector< std::vector< int > >::value_type const &)\n"
     "    std::vector< std::vector< int > >::insert(std::vector< std::vector< int > >::iterator,std::vector< std::vector< int > >::size_type,std::vector< std::vector< int > >::value_type const &)\n");
@@ -16346,7 +16346,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_reserve(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_reserve(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::size_type arg2 ;
@@ -16357,15 +16357,15 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_reserve(PyObject *self, PyObject *args)
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_t_reserve", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_T_reserve", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_reserve" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_reserve" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_t_reserve" "', argument " "2"" of type '" "std::vector< std::vector< int > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_T_reserve" "', argument " "2"" of type '" "std::vector< std::vector< int > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< int > >::size_type >(val2);
   (arg1)->reserve(arg2);
@@ -16376,7 +16376,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_capacity(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_capacity(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -16389,7 +16389,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_capacity(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_capacity" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_capacity" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = ((std::vector< std::vector< int > > const *)arg1)->capacity();
@@ -16400,7 +16400,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_delete_vinteger2d_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_delete_vinteger2d_T(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -16412,7 +16412,7 @@ SWIGINTERN PyObject *_wrap_delete_vinteger2d_t(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, SWIG_POINTER_DISOWN |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vinteger2d_t" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vinteger2d_T" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   {
@@ -16433,18 +16433,18 @@ fail:
 }
 
 
-SWIGINTERN PyObject *vinteger2d_t_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vinteger2d_T_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   PyObject *obj;
   if (!SWIG_Python_UnpackTuple(args, "swigregister", 1, 1, &obj)) return NULL;
   SWIG_TypeNewClientData(SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, SWIG_NewClientData(obj));
   return SWIG_Py_Void();
 }
 
-SWIGINTERN PyObject *vinteger2d_t_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vinteger2d_T_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   return SWIG_Python_InitShadowInstance(args);
 }
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_iterator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_iterator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   PyObject **arg2 = (PyObject **) 0 ;
@@ -16459,7 +16459,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_iterator(PyObject *self, PyObjec
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_iterator" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_iterator" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = (swig::SwigPyIterator *)std_vector_Sl_unsigned_SS_long_Sg__iterator(arg1,arg2);
@@ -16470,7 +16470,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___nonzero__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___nonzero__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -16483,7 +16483,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___nonzero__(PyObject *self, PyOb
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___nonzero__" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___nonzero__" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = (bool)std_vector_Sl_unsigned_SS_long_Sg____nonzero__((std::vector< unsigned long > const *)arg1);
@@ -16494,7 +16494,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___bool__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___bool__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -16507,7 +16507,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___bool__(PyObject *self, PyObjec
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___bool__" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___bool__" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = (bool)std_vector_Sl_unsigned_SS_long_Sg____bool__((std::vector< unsigned long > const *)arg1);
@@ -16518,7 +16518,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___len__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___len__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -16531,7 +16531,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___len__(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___len__" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___len__" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = std_vector_Sl_unsigned_SS_long_Sg____len__((std::vector< unsigned long > const *)arg1);
@@ -16542,7 +16542,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___getslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___getslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::difference_type arg2 ;
@@ -16557,20 +16557,20 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___getslice__(PyObject *self, PyO
   std::vector< unsigned long,std::allocator< unsigned long > > *result = 0 ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_t___getslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_T___getslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___getslice__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___getslice__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t___getslice__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T___getslice__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< unsigned long >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_t___getslice__" "', argument " "3"" of type '" "std::vector< unsigned long >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_T___getslice__" "', argument " "3"" of type '" "std::vector< unsigned long >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< unsigned long >::difference_type >(val3);
   try {
@@ -16587,7 +16587,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::difference_type arg2 ;
@@ -16603,17 +16603,17 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setslice____SWIG_0(PyObject *s
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___setslice__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___setslice__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t___setslice__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T___setslice__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< unsigned long >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_t___setslice__" "', argument " "3"" of type '" "std::vector< unsigned long >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_T___setslice__" "', argument " "3"" of type '" "std::vector< unsigned long >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< unsigned long >::difference_type >(val3);
   try {
@@ -16630,7 +16630,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::difference_type arg2 ;
@@ -16648,27 +16648,27 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setslice____SWIG_1(PyObject *s
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___setslice__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___setslice__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t___setslice__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T___setslice__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< unsigned long >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_t___setslice__" "', argument " "3"" of type '" "std::vector< unsigned long >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_T___setslice__" "', argument " "3"" of type '" "std::vector< unsigned long >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< unsigned long >::difference_type >(val3);
   {
     std::vector< unsigned long,std::allocator< unsigned long > > *ptr = (std::vector< unsigned long,std::allocator< unsigned long > > *)0;
     res4 = swig::asptr(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_longinteger_t___setslice__" "', argument " "4"" of type '" "std::vector< unsigned long,std::allocator< unsigned long > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_longinteger_T___setslice__" "', argument " "4"" of type '" "std::vector< unsigned long,std::allocator< unsigned long > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_longinteger_t___setslice__" "', argument " "4"" of type '" "std::vector< unsigned long,std::allocator< unsigned long > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_longinteger_T___setslice__" "', argument " "4"" of type '" "std::vector< unsigned long,std::allocator< unsigned long > > const &""'"); 
     }
     arg4 = ptr;
   }
@@ -16688,13 +16688,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___setslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___setslice__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_t___setslice__", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_T___setslice__", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -16711,7 +16711,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setslice__(PyObject *self, PyO
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_longinteger_t___setslice____SWIG_0(self, argc, argv);
+          return _wrap_vector_longinteger_T___setslice____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -16734,7 +16734,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setslice__(PyObject *self, PyO
           int res = swig::asptr(argv[3], (std::vector< unsigned long,std::allocator< unsigned long > >**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vector_longinteger_t___setslice____SWIG_1(self, argc, argv);
+            return _wrap_vector_longinteger_T___setslice____SWIG_1(self, argc, argv);
           }
         }
       }
@@ -16742,7 +16742,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setslice__(PyObject *self, PyO
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_t___setslice__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_T___setslice__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< unsigned long >::__setslice__(std::vector< unsigned long >::difference_type,std::vector< unsigned long >::difference_type)\n"
     "    std::vector< unsigned long >::__setslice__(std::vector< unsigned long >::difference_type,std::vector< unsigned long >::difference_type,std::vector< unsigned long,std::allocator< unsigned long > > const &)\n");
@@ -16750,7 +16750,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___delslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___delslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::difference_type arg2 ;
@@ -16764,20 +16764,20 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___delslice__(PyObject *self, PyO
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_t___delslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_T___delslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___delslice__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___delslice__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t___delslice__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T___delslice__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< unsigned long >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_t___delslice__" "', argument " "3"" of type '" "std::vector< unsigned long >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_T___delslice__" "', argument " "3"" of type '" "std::vector< unsigned long >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< unsigned long >::difference_type >(val3);
   try {
@@ -16794,7 +16794,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::difference_type arg2 ;
@@ -16807,12 +16807,12 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___delitem____SWIG_0(PyObject *se
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___delitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___delitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t___delitem__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T___delitem__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< unsigned long >::difference_type >(val2);
   try {
@@ -16829,7 +16829,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -16841,12 +16841,12 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___getitem____SWIG_0(PyObject *se
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___getitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___getitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -16864,7 +16864,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -16877,12 +16877,12 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setitem____SWIG_0(PyObject *se
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___setitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___setitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -16890,10 +16890,10 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setitem____SWIG_0(PyObject *se
     std::vector< unsigned long,std::allocator< unsigned long > > *ptr = (std::vector< unsigned long,std::allocator< unsigned long > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_longinteger_t___setitem__" "', argument " "3"" of type '" "std::vector< unsigned long,std::allocator< unsigned long > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_longinteger_T___setitem__" "', argument " "3"" of type '" "std::vector< unsigned long,std::allocator< unsigned long > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_longinteger_t___setitem__" "', argument " "3"" of type '" "std::vector< unsigned long,std::allocator< unsigned long > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_longinteger_T___setitem__" "', argument " "3"" of type '" "std::vector< unsigned long,std::allocator< unsigned long > > const &""'"); 
     }
     arg3 = ptr;
   }
@@ -16913,7 +16913,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -16924,12 +16924,12 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setitem____SWIG_1(PyObject *se
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___setitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___setitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -16947,7 +16947,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -16958,12 +16958,12 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___delitem____SWIG_1(PyObject *se
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___delitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___delitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -16981,13 +16981,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___delitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___delitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_t___delitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_T___delitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -16998,7 +16998,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___delitem__(PyObject *self, PyOb
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_longinteger_t___delitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_longinteger_T___delitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -17012,13 +17012,13 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___delitem__(PyObject *self, PyOb
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_longinteger_t___delitem____SWIG_0(self, argc, argv);
+        return _wrap_vector_longinteger_T___delitem____SWIG_0(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_t___delitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_T___delitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< unsigned long >::__delitem__(std::vector< unsigned long >::difference_type)\n"
     "    std::vector< unsigned long >::__delitem__(SWIGPY_SLICEOBJECT *)\n");
@@ -17026,7 +17026,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::difference_type arg2 ;
@@ -17040,12 +17040,12 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___getitem____SWIG_1(PyObject *se
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___getitem__" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___getitem__" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t___getitem__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T___getitem__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< unsigned long >::difference_type >(val2);
   try {
@@ -17061,13 +17061,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___getitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___getitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_t___getitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_T___getitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -17078,7 +17078,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___getitem__(PyObject *self, PyOb
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_longinteger_t___getitem____SWIG_0(self, argc, argv);
+        return _wrap_vector_longinteger_T___getitem____SWIG_0(self, argc, argv);
       }
     }
   }
@@ -17092,13 +17092,13 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___getitem__(PyObject *self, PyOb
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_longinteger_t___getitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_longinteger_T___getitem____SWIG_1(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_t___getitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_T___getitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< unsigned long >::__getitem__(SWIGPY_SLICEOBJECT *)\n"
     "    std::vector< unsigned long >::__getitem__(std::vector< unsigned long >::difference_type) const\n");
@@ -17106,7 +17106,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::difference_type arg2 ;
@@ -17123,17 +17123,17 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setitem____SWIG_2(PyObject *se
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___setitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___setitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t___setitem__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T___setitem__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< unsigned long >::difference_type >(val2);
   ecode3 = SWIG_AsVal_unsigned_SS_long(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_t___setitem__" "', argument " "3"" of type '" "std::vector< unsigned long >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_T___setitem__" "', argument " "3"" of type '" "std::vector< unsigned long >::value_type""'");
   } 
   temp3 = static_cast< std::vector< unsigned long >::value_type >(val3);
   arg3 = &temp3;
@@ -17149,13 +17149,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___setitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___setitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_t___setitem__", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_T___setitem__", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -17166,7 +17166,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setitem__(PyObject *self, PyOb
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_longinteger_t___setitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_longinteger_T___setitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -17182,7 +17182,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setitem__(PyObject *self, PyOb
         int res = swig::asptr(argv[2], (std::vector< unsigned long,std::allocator< unsigned long > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vector_longinteger_t___setitem____SWIG_0(self, argc, argv);
+          return _wrap_vector_longinteger_T___setitem____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -17202,14 +17202,14 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setitem__(PyObject *self, PyOb
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_longinteger_t___setitem____SWIG_2(self, argc, argv);
+          return _wrap_vector_longinteger_T___setitem____SWIG_2(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_t___setitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_T___setitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< unsigned long >::__setitem__(SWIGPY_SLICEOBJECT *,std::vector< unsigned long,std::allocator< unsigned long > > const &)\n"
     "    std::vector< unsigned long >::__setitem__(SWIGPY_SLICEOBJECT *)\n"
@@ -17218,7 +17218,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_pop(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_pop(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -17231,7 +17231,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_pop(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_pop" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_pop" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   try {
@@ -17246,7 +17246,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_append(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_append(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::value_type *arg2 = 0 ;
@@ -17258,15 +17258,15 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_append(PyObject *self, PyObject
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_t_append", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_T_append", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_append" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_append" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_unsigned_SS_long(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t_append" "', argument " "2"" of type '" "std::vector< unsigned long >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T_append" "', argument " "2"" of type '" "std::vector< unsigned long >::value_type""'");
   } 
   temp2 = static_cast< std::vector< unsigned long >::value_type >(val2);
   arg2 = &temp2;
@@ -17278,7 +17278,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_longinteger_t__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
+SWIGINTERN PyObject *_wrap_new_vector_longinteger_T__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *result = 0 ;
   
@@ -17292,7 +17292,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_longinteger_t__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_longinteger_T__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = 0 ;
   int res1 = SWIG_OLDOBJ ;
@@ -17304,10 +17304,10 @@ SWIGINTERN PyObject *_wrap_new_vector_longinteger_t__SWIG_1(PyObject *self, Py_s
     std::vector< unsigned long,std::allocator< unsigned long > > *ptr = (std::vector< unsigned long,std::allocator< unsigned long > > *)0;
     res1 = swig::asptr(swig_obj[0], &ptr);
     if (!SWIG_IsOK(res1)) {
-      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vector_longinteger_t" "', argument " "1"" of type '" "std::vector< unsigned long > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vector_longinteger_T" "', argument " "1"" of type '" "std::vector< unsigned long > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_longinteger_t" "', argument " "1"" of type '" "std::vector< unsigned long > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_longinteger_T" "', argument " "1"" of type '" "std::vector< unsigned long > const &""'"); 
     }
     arg1 = ptr;
   }
@@ -17321,7 +17321,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_empty(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_empty(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -17334,7 +17334,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_empty(PyObject *self, PyObject *
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_empty" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_empty" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = (bool)((std::vector< unsigned long > const *)arg1)->empty();
@@ -17345,7 +17345,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_size(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_size(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -17358,7 +17358,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_size(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_size" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_size" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = ((std::vector< unsigned long > const *)arg1)->size();
@@ -17369,7 +17369,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_swap(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_swap(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long > *arg2 = 0 ;
@@ -17380,18 +17380,18 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_swap(PyObject *self, PyObject *a
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_t_swap", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_T_swap", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_swap" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_swap" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], &argp2, SWIGTYPE_p_std__vectorT_unsigned_long_t,  0 );
   if (!SWIG_IsOK(res2)) {
-    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_longinteger_t_swap" "', argument " "2"" of type '" "std::vector< unsigned long > &""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_longinteger_T_swap" "', argument " "2"" of type '" "std::vector< unsigned long > &""'"); 
   }
   if (!argp2) {
-    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_longinteger_t_swap" "', argument " "2"" of type '" "std::vector< unsigned long > &""'"); 
+    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_longinteger_T_swap" "', argument " "2"" of type '" "std::vector< unsigned long > &""'"); 
   }
   arg2 = reinterpret_cast< std::vector< unsigned long > * >(argp2);
   (arg1)->swap(*arg2);
@@ -17402,7 +17402,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_begin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_begin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -17415,7 +17415,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_begin(PyObject *self, PyObject *
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_begin" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_begin" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = (arg1)->begin();
@@ -17427,7 +17427,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_end(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_end(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -17440,7 +17440,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_end(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_end" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_end" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = (arg1)->end();
@@ -17452,7 +17452,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_rbegin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_rbegin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -17465,7 +17465,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_rbegin(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_rbegin" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_rbegin" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = (arg1)->rbegin();
@@ -17477,7 +17477,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_rend(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_rend(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -17490,7 +17490,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_rend(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_rend" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_rend" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = (arg1)->rend();
@@ -17502,7 +17502,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_clear(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_clear(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -17514,7 +17514,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_clear(PyObject *self, PyObject *
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_clear" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_clear" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   (arg1)->clear();
@@ -17525,7 +17525,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_get_allocator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_get_allocator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -17538,7 +17538,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_get_allocator(PyObject *self, Py
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_get_allocator" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_get_allocator" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = ((std::vector< unsigned long > const *)arg1)->get_allocator();
@@ -17549,7 +17549,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_longinteger_t__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_longinteger_T__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long >::size_type arg1 ;
   size_t val1 ;
@@ -17560,7 +17560,7 @@ SWIGINTERN PyObject *_wrap_new_vector_longinteger_t__SWIG_2(PyObject *self, Py_s
   if ((nobjs < 1) || (nobjs > 1)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_longinteger_t" "', argument " "1"" of type '" "std::vector< unsigned long >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_longinteger_T" "', argument " "1"" of type '" "std::vector< unsigned long >::size_type""'");
   } 
   arg1 = static_cast< std::vector< unsigned long >::size_type >(val1);
   result = (std::vector< unsigned long > *)new std::vector< unsigned long >(arg1);
@@ -17571,7 +17571,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_pop_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_pop_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -17583,7 +17583,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_pop_back(PyObject *self, PyObjec
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_pop_back" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_pop_back" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   (arg1)->pop_back();
@@ -17594,7 +17594,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::size_type arg2 ;
@@ -17607,12 +17607,12 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_resize__SWIG_0(PyObject *self, P
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_resize" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_resize" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t_resize" "', argument " "2"" of type '" "std::vector< unsigned long >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T_resize" "', argument " "2"" of type '" "std::vector< unsigned long >::size_type""'");
   } 
   arg2 = static_cast< std::vector< unsigned long >::size_type >(val2);
   (arg1)->resize(arg2);
@@ -17623,7 +17623,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::iterator arg2 ;
@@ -17637,18 +17637,18 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_erase__SWIG_0(PyObject *self, Py
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_erase" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_erase" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t_erase" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T_erase" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t_erase" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T_erase" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
     }
   }
   result = std_vector_Sl_unsigned_SS_long_Sg__erase__SWIG_0(arg1,SWIG_STD_MOVE(arg2));
@@ -17660,7 +17660,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::iterator arg2 ;
@@ -17677,29 +17677,29 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_erase__SWIG_1(PyObject *self, Py
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_erase" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_erase" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t_erase" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T_erase" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t_erase" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T_erase" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
     }
   }
   res3 = SWIG_ConvertPtr(swig_obj[2], SWIG_as_voidptrptr(&iter3), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res3) || !iter3) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t_erase" "', argument " "3"" of type '" "std::vector< unsigned long >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T_erase" "', argument " "3"" of type '" "std::vector< unsigned long >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *>(iter3);
     if (iter_t) {
       arg3 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t_erase" "', argument " "3"" of type '" "std::vector< unsigned long >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T_erase" "', argument " "3"" of type '" "std::vector< unsigned long >::iterator""'");
     }
   }
   result = std_vector_Sl_unsigned_SS_long_Sg__erase__SWIG_1(arg1,SWIG_STD_MOVE(arg2),SWIG_STD_MOVE(arg3));
@@ -17711,13 +17711,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_erase(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_erase(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_t_erase", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_T_erase", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -17728,7 +17728,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_erase(PyObject *self, PyObject *
       int res = SWIG_ConvertPtr(argv[1], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
       _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *>(iter) != 0));
       if (_v) {
-        return _wrap_vector_longinteger_t_erase__SWIG_0(self, argc, argv);
+        return _wrap_vector_longinteger_T_erase__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -17745,14 +17745,14 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_erase(PyObject *self, PyObject *
         int res = SWIG_ConvertPtr(argv[2], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
         _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *>(iter) != 0));
         if (_v) {
-          return _wrap_vector_longinteger_t_erase__SWIG_1(self, argc, argv);
+          return _wrap_vector_longinteger_T_erase__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_t_erase'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_T_erase'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< unsigned long >::erase(std::vector< unsigned long >::iterator)\n"
     "    std::vector< unsigned long >::erase(std::vector< unsigned long >::iterator,std::vector< unsigned long >::iterator)\n");
@@ -17760,7 +17760,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_longinteger_t__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_longinteger_T__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long >::size_type arg1 ;
   std::vector< unsigned long >::value_type *arg2 = 0 ;
@@ -17775,12 +17775,12 @@ SWIGINTERN PyObject *_wrap_new_vector_longinteger_t__SWIG_3(PyObject *self, Py_s
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_longinteger_t" "', argument " "1"" of type '" "std::vector< unsigned long >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_longinteger_T" "', argument " "1"" of type '" "std::vector< unsigned long >::size_type""'");
   } 
   arg1 = static_cast< std::vector< unsigned long >::size_type >(val1);
   ecode2 = SWIG_AsVal_unsigned_SS_long(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "new_vector_longinteger_t" "', argument " "2"" of type '" "std::vector< unsigned long >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "new_vector_longinteger_T" "', argument " "2"" of type '" "std::vector< unsigned long >::value_type""'");
   } 
   temp2 = static_cast< std::vector< unsigned long >::value_type >(val2);
   arg2 = &temp2;
@@ -17792,16 +17792,16 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_longinteger_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_new_vector_longinteger_T(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vector_longinteger_t", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vector_longinteger_T", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 0) {
-    return _wrap_new_vector_longinteger_t__SWIG_0(self, argc, argv);
+    return _wrap_new_vector_longinteger_T__SWIG_0(self, argc, argv);
   }
   if (argc == 1) {
     int _v = 0;
@@ -17810,7 +17810,7 @@ SWIGINTERN PyObject *_wrap_new_vector_longinteger_t(PyObject *self, PyObject *ar
       _v = SWIG_CheckState(res);
     }
     if (_v) {
-      return _wrap_new_vector_longinteger_t__SWIG_2(self, argc, argv);
+      return _wrap_new_vector_longinteger_T__SWIG_2(self, argc, argv);
     }
   }
   if (argc == 1) {
@@ -17818,7 +17818,7 @@ SWIGINTERN PyObject *_wrap_new_vector_longinteger_t(PyObject *self, PyObject *ar
     int res = swig::asptr(argv[0], (std::vector< unsigned long,std::allocator< unsigned long > >**)(0));
     _v = SWIG_CheckState(res);
     if (_v) {
-      return _wrap_new_vector_longinteger_t__SWIG_1(self, argc, argv);
+      return _wrap_new_vector_longinteger_T__SWIG_1(self, argc, argv);
     }
   }
   if (argc == 2) {
@@ -17833,13 +17833,13 @@ SWIGINTERN PyObject *_wrap_new_vector_longinteger_t(PyObject *self, PyObject *ar
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_new_vector_longinteger_t__SWIG_3(self, argc, argv);
+        return _wrap_new_vector_longinteger_T__SWIG_3(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vector_longinteger_t'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vector_longinteger_T'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< unsigned long >::vector()\n"
     "    std::vector< unsigned long >::vector(std::vector< unsigned long > const &)\n"
@@ -17849,7 +17849,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_push_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_push_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::value_type *arg2 = 0 ;
@@ -17861,15 +17861,15 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_push_back(PyObject *self, PyObje
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_t_push_back", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_T_push_back", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_push_back" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_push_back" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_unsigned_SS_long(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t_push_back" "', argument " "2"" of type '" "std::vector< unsigned long >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T_push_back" "', argument " "2"" of type '" "std::vector< unsigned long >::value_type""'");
   } 
   temp2 = static_cast< std::vector< unsigned long >::value_type >(val2);
   arg2 = &temp2;
@@ -17881,7 +17881,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_front(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_front(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -17894,7 +17894,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_front(PyObject *self, PyObject *
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_front" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_front" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = (std::vector< unsigned long >::value_type *) &((std::vector< unsigned long > const *)arg1)->front();
@@ -17906,7 +17906,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -17919,7 +17919,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_back(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_back" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_back" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = (std::vector< unsigned long >::value_type *) &((std::vector< unsigned long > const *)arg1)->back();
@@ -17931,7 +17931,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_assign(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_assign(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::size_type arg2 ;
@@ -17946,20 +17946,20 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_assign(PyObject *self, PyObject
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_t_assign", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_T_assign", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_assign" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_assign" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t_assign" "', argument " "2"" of type '" "std::vector< unsigned long >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T_assign" "', argument " "2"" of type '" "std::vector< unsigned long >::size_type""'");
   } 
   arg2 = static_cast< std::vector< unsigned long >::size_type >(val2);
   ecode3 = SWIG_AsVal_unsigned_SS_long(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_t_assign" "', argument " "3"" of type '" "std::vector< unsigned long >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_T_assign" "', argument " "3"" of type '" "std::vector< unsigned long >::value_type""'");
   } 
   temp3 = static_cast< std::vector< unsigned long >::value_type >(val3);
   arg3 = &temp3;
@@ -17971,7 +17971,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::size_type arg2 ;
@@ -17988,17 +17988,17 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_resize__SWIG_1(PyObject *self, P
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_resize" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_resize" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t_resize" "', argument " "2"" of type '" "std::vector< unsigned long >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T_resize" "', argument " "2"" of type '" "std::vector< unsigned long >::size_type""'");
   } 
   arg2 = static_cast< std::vector< unsigned long >::size_type >(val2);
   ecode3 = SWIG_AsVal_unsigned_SS_long(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_t_resize" "', argument " "3"" of type '" "std::vector< unsigned long >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_T_resize" "', argument " "3"" of type '" "std::vector< unsigned long >::value_type""'");
   } 
   temp3 = static_cast< std::vector< unsigned long >::value_type >(val3);
   arg3 = &temp3;
@@ -18010,13 +18010,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_resize(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_resize(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_t_resize", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_T_resize", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -18028,7 +18028,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_resize(PyObject *self, PyObject
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_longinteger_t_resize__SWIG_0(self, argc, argv);
+        return _wrap_vector_longinteger_T_resize__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -18047,14 +18047,14 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_resize(PyObject *self, PyObject
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_longinteger_t_resize__SWIG_1(self, argc, argv);
+          return _wrap_vector_longinteger_T_resize__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_t_resize'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_T_resize'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< unsigned long >::resize(std::vector< unsigned long >::size_type)\n"
     "    std::vector< unsigned long >::resize(std::vector< unsigned long >::size_type,std::vector< unsigned long >::value_type const &)\n");
@@ -18062,7 +18062,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::iterator arg2 ;
@@ -18080,23 +18080,23 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_insert__SWIG_0(PyObject *self, P
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_insert" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_insert" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t_insert" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T_insert" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t_insert" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T_insert" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_unsigned_SS_long(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_t_insert" "', argument " "3"" of type '" "std::vector< unsigned long >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_T_insert" "', argument " "3"" of type '" "std::vector< unsigned long >::value_type""'");
   } 
   temp3 = static_cast< std::vector< unsigned long >::value_type >(val3);
   arg3 = &temp3;
@@ -18109,7 +18109,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::iterator arg2 ;
@@ -18129,28 +18129,28 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_insert__SWIG_1(PyObject *self, P
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_insert" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_insert" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t_insert" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T_insert" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t_insert" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T_insert" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_size_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_t_insert" "', argument " "3"" of type '" "std::vector< unsigned long >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_T_insert" "', argument " "3"" of type '" "std::vector< unsigned long >::size_type""'");
   } 
   arg3 = static_cast< std::vector< unsigned long >::size_type >(val3);
   ecode4 = SWIG_AsVal_unsigned_SS_long(swig_obj[3], &val4);
   if (!SWIG_IsOK(ecode4)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode4), "in method '" "vector_longinteger_t_insert" "', argument " "4"" of type '" "std::vector< unsigned long >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode4), "in method '" "vector_longinteger_T_insert" "', argument " "4"" of type '" "std::vector< unsigned long >::value_type""'");
   } 
   temp4 = static_cast< std::vector< unsigned long >::value_type >(val4);
   arg4 = &temp4;
@@ -18162,13 +18162,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_insert(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_insert(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_t_insert", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_T_insert", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -18184,7 +18184,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_insert(PyObject *self, PyObject
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_longinteger_t_insert__SWIG_0(self, argc, argv);
+          return _wrap_vector_longinteger_T_insert__SWIG_0(self, argc, argv);
         }
       }
     }
@@ -18208,7 +18208,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_insert(PyObject *self, PyObject
             _v = SWIG_CheckState(res);
           }
           if (_v) {
-            return _wrap_vector_longinteger_t_insert__SWIG_1(self, argc, argv);
+            return _wrap_vector_longinteger_T_insert__SWIG_1(self, argc, argv);
           }
         }
       }
@@ -18216,7 +18216,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_insert(PyObject *self, PyObject
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_t_insert'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_T_insert'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< unsigned long >::insert(std::vector< unsigned long >::iterator,std::vector< unsigned long >::value_type const &)\n"
     "    std::vector< unsigned long >::insert(std::vector< unsigned long >::iterator,std::vector< unsigned long >::size_type,std::vector< unsigned long >::value_type const &)\n");
@@ -18224,7 +18224,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_reserve(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_reserve(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::size_type arg2 ;
@@ -18235,15 +18235,15 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_reserve(PyObject *self, PyObject
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_t_reserve", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_T_reserve", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_reserve" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_reserve" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t_reserve" "', argument " "2"" of type '" "std::vector< unsigned long >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T_reserve" "', argument " "2"" of type '" "std::vector< unsigned long >::size_type""'");
   } 
   arg2 = static_cast< std::vector< unsigned long >::size_type >(val2);
   (arg1)->reserve(arg2);
@@ -18254,7 +18254,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_capacity(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_capacity(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -18267,7 +18267,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_capacity(PyObject *self, PyObjec
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_capacity" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_capacity" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = ((std::vector< unsigned long > const *)arg1)->capacity();
@@ -18278,7 +18278,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_delete_vector_longinteger_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_delete_vector_longinteger_T(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -18290,7 +18290,7 @@ SWIGINTERN PyObject *_wrap_delete_vector_longinteger_t(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, SWIG_POINTER_DISOWN |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vector_longinteger_t" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vector_longinteger_T" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   {
@@ -18311,18 +18311,18 @@ fail:
 }
 
 
-SWIGINTERN PyObject *vector_longinteger_t_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vector_longinteger_T_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   PyObject *obj;
   if (!SWIG_Python_UnpackTuple(args, "swigregister", 1, 1, &obj)) return NULL;
   SWIG_TypeNewClientData(SWIGTYPE_p_std__vectorT_unsigned_long_t, SWIG_NewClientData(obj));
   return SWIG_Py_Void();
 }
 
-SWIGINTERN PyObject *vector_longinteger_t_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vector_longinteger_T_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   return SWIG_Python_InitShadowInstance(args);
 }
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_iterator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_iterator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   PyObject **arg2 = (PyObject **) 0 ;
@@ -18337,7 +18337,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_iterator(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_iterator" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_iterator" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = (swig::SwigPyIterator *)std_vector_Sl_std_complex_Sl_double_Sg__Sg__iterator(arg1,arg2);
@@ -18348,7 +18348,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___nonzero__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___nonzero__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -18361,7 +18361,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___nonzero__(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___nonzero__" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___nonzero__" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = (bool)std_vector_Sl_std_complex_Sl_double_Sg__Sg____nonzero__((std::vector< std::complex< double > > const *)arg1);
@@ -18372,7 +18372,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___bool__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___bool__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -18385,7 +18385,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___bool__(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___bool__" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___bool__" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = (bool)std_vector_Sl_std_complex_Sl_double_Sg__Sg____bool__((std::vector< std::complex< double > > const *)arg1);
@@ -18396,7 +18396,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___len__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___len__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -18409,7 +18409,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___len__(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___len__" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___len__" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = std_vector_Sl_std_complex_Sl_double_Sg__Sg____len__((std::vector< std::complex< double > > const *)arg1);
@@ -18420,7 +18420,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___getslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___getslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::difference_type arg2 ;
@@ -18435,20 +18435,20 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___getslice__(PyObject *self, PyObjec
   std::vector< std::complex< double >,std::allocator< std::complex< double > > > *result = 0 ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_complex_t___getslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_complex_T___getslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___getslice__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___getslice__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t___getslice__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T___getslice__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::complex< double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_t___getslice__" "', argument " "3"" of type '" "std::vector< std::complex< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_T___getslice__" "', argument " "3"" of type '" "std::vector< std::complex< double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::complex< double > >::difference_type >(val3);
   try {
@@ -18465,7 +18465,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::difference_type arg2 ;
@@ -18481,17 +18481,17 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setslice____SWIG_0(PyObject *self,
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___setslice__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___setslice__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t___setslice__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T___setslice__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::complex< double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_t___setslice__" "', argument " "3"" of type '" "std::vector< std::complex< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_T___setslice__" "', argument " "3"" of type '" "std::vector< std::complex< double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::complex< double > >::difference_type >(val3);
   try {
@@ -18508,7 +18508,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::difference_type arg2 ;
@@ -18526,27 +18526,27 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setslice____SWIG_1(PyObject *self,
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___setslice__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___setslice__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t___setslice__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T___setslice__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::complex< double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_t___setslice__" "', argument " "3"" of type '" "std::vector< std::complex< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_T___setslice__" "', argument " "3"" of type '" "std::vector< std::complex< double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::complex< double > >::difference_type >(val3);
   {
     std::vector< std::complex< double >,std::allocator< std::complex< double > > > *ptr = (std::vector< std::complex< double >,std::allocator< std::complex< double > > > *)0;
     res4 = swig::asptr(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_complex_t___setslice__" "', argument " "4"" of type '" "std::vector< std::complex< double >,std::allocator< std::complex< double > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_complex_T___setslice__" "', argument " "4"" of type '" "std::vector< std::complex< double >,std::allocator< std::complex< double > > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_complex_t___setslice__" "', argument " "4"" of type '" "std::vector< std::complex< double >,std::allocator< std::complex< double > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_complex_T___setslice__" "', argument " "4"" of type '" "std::vector< std::complex< double >,std::allocator< std::complex< double > > > const &""'"); 
     }
     arg4 = ptr;
   }
@@ -18566,13 +18566,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___setslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___setslice__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_t___setslice__", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_T___setslice__", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -18589,7 +18589,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setslice__(PyObject *self, PyObjec
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_complex_t___setslice____SWIG_0(self, argc, argv);
+          return _wrap_vector_complex_T___setslice____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -18612,7 +18612,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setslice__(PyObject *self, PyObjec
           int res = swig::asptr(argv[3], (std::vector< std::complex< double >,std::allocator< std::complex< double > > >**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vector_complex_t___setslice____SWIG_1(self, argc, argv);
+            return _wrap_vector_complex_T___setslice____SWIG_1(self, argc, argv);
           }
         }
       }
@@ -18620,7 +18620,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setslice__(PyObject *self, PyObjec
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_t___setslice__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_T___setslice__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::complex< double > >::__setslice__(std::vector< std::complex< double > >::difference_type,std::vector< std::complex< double > >::difference_type)\n"
     "    std::vector< std::complex< double > >::__setslice__(std::vector< std::complex< double > >::difference_type,std::vector< std::complex< double > >::difference_type,std::vector< std::complex< double >,std::allocator< std::complex< double > > > const &)\n");
@@ -18628,7 +18628,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___delslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___delslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::difference_type arg2 ;
@@ -18642,20 +18642,20 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___delslice__(PyObject *self, PyObjec
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_complex_t___delslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_complex_T___delslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___delslice__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___delslice__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t___delslice__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T___delslice__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::complex< double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_t___delslice__" "', argument " "3"" of type '" "std::vector< std::complex< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_T___delslice__" "', argument " "3"" of type '" "std::vector< std::complex< double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::complex< double > >::difference_type >(val3);
   try {
@@ -18672,7 +18672,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::difference_type arg2 ;
@@ -18685,12 +18685,12 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___delitem____SWIG_0(PyObject *self,
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___delitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___delitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t___delitem__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T___delitem__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::complex< double > >::difference_type >(val2);
   try {
@@ -18707,7 +18707,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -18719,12 +18719,12 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___getitem____SWIG_0(PyObject *self,
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___getitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___getitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -18742,7 +18742,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -18755,12 +18755,12 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setitem____SWIG_0(PyObject *self,
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___setitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___setitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -18768,10 +18768,10 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setitem____SWIG_0(PyObject *self,
     std::vector< std::complex< double >,std::allocator< std::complex< double > > > *ptr = (std::vector< std::complex< double >,std::allocator< std::complex< double > > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_complex_t___setitem__" "', argument " "3"" of type '" "std::vector< std::complex< double >,std::allocator< std::complex< double > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_complex_T___setitem__" "', argument " "3"" of type '" "std::vector< std::complex< double >,std::allocator< std::complex< double > > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_complex_t___setitem__" "', argument " "3"" of type '" "std::vector< std::complex< double >,std::allocator< std::complex< double > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_complex_T___setitem__" "', argument " "3"" of type '" "std::vector< std::complex< double >,std::allocator< std::complex< double > > > const &""'"); 
     }
     arg3 = ptr;
   }
@@ -18791,7 +18791,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -18802,12 +18802,12 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setitem____SWIG_1(PyObject *self,
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___setitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___setitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -18825,7 +18825,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -18836,12 +18836,12 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___delitem____SWIG_1(PyObject *self,
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___delitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___delitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -18859,13 +18859,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___delitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___delitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_t___delitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_T___delitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -18876,7 +18876,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___delitem__(PyObject *self, PyObject
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_complex_t___delitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_complex_T___delitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -18890,13 +18890,13 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___delitem__(PyObject *self, PyObject
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_complex_t___delitem____SWIG_0(self, argc, argv);
+        return _wrap_vector_complex_T___delitem____SWIG_0(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_t___delitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_T___delitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::complex< double > >::__delitem__(std::vector< std::complex< double > >::difference_type)\n"
     "    std::vector< std::complex< double > >::__delitem__(SWIGPY_SLICEOBJECT *)\n");
@@ -18904,7 +18904,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::difference_type arg2 ;
@@ -18918,12 +18918,12 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___getitem____SWIG_1(PyObject *self,
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___getitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___getitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t___getitem__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T___getitem__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::complex< double > >::difference_type >(val2);
   try {
@@ -18939,13 +18939,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___getitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___getitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_t___getitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_T___getitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -18956,7 +18956,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___getitem__(PyObject *self, PyObject
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_complex_t___getitem____SWIG_0(self, argc, argv);
+        return _wrap_vector_complex_T___getitem____SWIG_0(self, argc, argv);
       }
     }
   }
@@ -18970,13 +18970,13 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___getitem__(PyObject *self, PyObject
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_complex_t___getitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_complex_T___getitem____SWIG_1(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_t___getitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_T___getitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::complex< double > >::__getitem__(SWIGPY_SLICEOBJECT *)\n"
     "    std::vector< std::complex< double > >::__getitem__(std::vector< std::complex< double > >::difference_type) const\n");
@@ -18984,7 +18984,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::difference_type arg2 ;
@@ -19001,17 +19001,17 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setitem____SWIG_2(PyObject *self,
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___setitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___setitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t___setitem__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T___setitem__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::complex< double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_std_complex_Sl_double_Sg_(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_t___setitem__" "', argument " "3"" of type '" "std::vector< std::complex< double > >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_T___setitem__" "', argument " "3"" of type '" "std::vector< std::complex< double > >::value_type""'");
   } 
   temp3 = static_cast< std::vector< std::complex< double > >::value_type >(val3);
   arg3 = &temp3;
@@ -19027,13 +19027,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___setitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___setitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_t___setitem__", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_T___setitem__", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -19044,7 +19044,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setitem__(PyObject *self, PyObject
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_complex_t___setitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_complex_T___setitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -19060,7 +19060,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setitem__(PyObject *self, PyObject
         int res = swig::asptr(argv[2], (std::vector< std::complex< double >,std::allocator< std::complex< double > > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vector_complex_t___setitem____SWIG_0(self, argc, argv);
+          return _wrap_vector_complex_T___setitem____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -19080,14 +19080,14 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setitem__(PyObject *self, PyObject
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_complex_t___setitem____SWIG_2(self, argc, argv);
+          return _wrap_vector_complex_T___setitem____SWIG_2(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_t___setitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_T___setitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::complex< double > >::__setitem__(SWIGPY_SLICEOBJECT *,std::vector< std::complex< double >,std::allocator< std::complex< double > > > const &)\n"
     "    std::vector< std::complex< double > >::__setitem__(SWIGPY_SLICEOBJECT *)\n"
@@ -19096,7 +19096,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_pop(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_pop(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -19109,7 +19109,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_pop(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_pop" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_pop" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   try {
@@ -19124,7 +19124,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_append(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_append(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::value_type *arg2 = 0 ;
@@ -19136,15 +19136,15 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_append(PyObject *self, PyObject *arg
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_complex_t_append", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_complex_T_append", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_append" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_append" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_std_complex_Sl_double_Sg_(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t_append" "', argument " "2"" of type '" "std::vector< std::complex< double > >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T_append" "', argument " "2"" of type '" "std::vector< std::complex< double > >::value_type""'");
   } 
   temp2 = static_cast< std::vector< std::complex< double > >::value_type >(val2);
   arg2 = &temp2;
@@ -19156,7 +19156,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_complex_t__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
+SWIGINTERN PyObject *_wrap_new_vector_complex_T__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *result = 0 ;
   
@@ -19170,7 +19170,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_complex_t__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_complex_T__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = 0 ;
   int res1 = SWIG_OLDOBJ ;
@@ -19182,10 +19182,10 @@ SWIGINTERN PyObject *_wrap_new_vector_complex_t__SWIG_1(PyObject *self, Py_ssize
     std::vector< std::complex< double >,std::allocator< std::complex< double > > > *ptr = (std::vector< std::complex< double >,std::allocator< std::complex< double > > > *)0;
     res1 = swig::asptr(swig_obj[0], &ptr);
     if (!SWIG_IsOK(res1)) {
-      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vector_complex_t" "', argument " "1"" of type '" "std::vector< std::complex< double > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vector_complex_T" "', argument " "1"" of type '" "std::vector< std::complex< double > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_complex_t" "', argument " "1"" of type '" "std::vector< std::complex< double > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_complex_T" "', argument " "1"" of type '" "std::vector< std::complex< double > > const &""'"); 
     }
     arg1 = ptr;
   }
@@ -19199,7 +19199,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_empty(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_empty(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -19212,7 +19212,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_empty(PyObject *self, PyObject *args
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_empty" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_empty" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = (bool)((std::vector< std::complex< double > > const *)arg1)->empty();
@@ -19223,7 +19223,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_size(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_size(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -19236,7 +19236,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_size(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_size" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_size" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = ((std::vector< std::complex< double > > const *)arg1)->size();
@@ -19247,7 +19247,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_swap(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_swap(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > > *arg2 = 0 ;
@@ -19258,18 +19258,18 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_swap(PyObject *self, PyObject *args)
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_complex_t_swap", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_complex_T_swap", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_swap" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_swap" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], &argp2, SWIGTYPE_p_std__vectorT_std__complexT_double_t_t,  0 );
   if (!SWIG_IsOK(res2)) {
-    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_complex_t_swap" "', argument " "2"" of type '" "std::vector< std::complex< double > > &""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_complex_T_swap" "', argument " "2"" of type '" "std::vector< std::complex< double > > &""'"); 
   }
   if (!argp2) {
-    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_complex_t_swap" "', argument " "2"" of type '" "std::vector< std::complex< double > > &""'"); 
+    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_complex_T_swap" "', argument " "2"" of type '" "std::vector< std::complex< double > > &""'"); 
   }
   arg2 = reinterpret_cast< std::vector< std::complex< double > > * >(argp2);
   (arg1)->swap(*arg2);
@@ -19280,7 +19280,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_begin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_begin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -19293,7 +19293,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_begin(PyObject *self, PyObject *args
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_begin" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_begin" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = (arg1)->begin();
@@ -19305,7 +19305,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_end(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_end(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -19318,7 +19318,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_end(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_end" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_end" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = (arg1)->end();
@@ -19330,7 +19330,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_rbegin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_rbegin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -19343,7 +19343,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_rbegin(PyObject *self, PyObject *arg
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_rbegin" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_rbegin" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = (arg1)->rbegin();
@@ -19355,7 +19355,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_rend(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_rend(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -19368,7 +19368,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_rend(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_rend" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_rend" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = (arg1)->rend();
@@ -19380,7 +19380,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_clear(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_clear(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -19392,7 +19392,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_clear(PyObject *self, PyObject *args
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_clear" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_clear" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   (arg1)->clear();
@@ -19403,7 +19403,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_get_allocator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_get_allocator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -19416,7 +19416,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_get_allocator(PyObject *self, PyObje
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_get_allocator" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_get_allocator" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = ((std::vector< std::complex< double > > const *)arg1)->get_allocator();
@@ -19427,7 +19427,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_complex_t__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_complex_T__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > >::size_type arg1 ;
   size_t val1 ;
@@ -19438,7 +19438,7 @@ SWIGINTERN PyObject *_wrap_new_vector_complex_t__SWIG_2(PyObject *self, Py_ssize
   if ((nobjs < 1) || (nobjs > 1)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_complex_t" "', argument " "1"" of type '" "std::vector< std::complex< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_complex_T" "', argument " "1"" of type '" "std::vector< std::complex< double > >::size_type""'");
   } 
   arg1 = static_cast< std::vector< std::complex< double > >::size_type >(val1);
   result = (std::vector< std::complex< double > > *)new std::vector< std::complex< double > >(arg1);
@@ -19449,7 +19449,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_pop_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_pop_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -19461,7 +19461,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_pop_back(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_pop_back" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_pop_back" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   (arg1)->pop_back();
@@ -19472,7 +19472,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::size_type arg2 ;
@@ -19485,12 +19485,12 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_resize__SWIG_0(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_resize" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_resize" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t_resize" "', argument " "2"" of type '" "std::vector< std::complex< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T_resize" "', argument " "2"" of type '" "std::vector< std::complex< double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::complex< double > >::size_type >(val2);
   (arg1)->resize(arg2);
@@ -19501,7 +19501,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::iterator arg2 ;
@@ -19515,18 +19515,18 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_erase__SWIG_0(PyObject *self, Py_ssi
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_erase" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_erase" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t_erase" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T_erase" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t_erase" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T_erase" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
     }
   }
   result = std_vector_Sl_std_complex_Sl_double_Sg__Sg__erase__SWIG_0(arg1,SWIG_STD_MOVE(arg2));
@@ -19538,7 +19538,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::iterator arg2 ;
@@ -19555,29 +19555,29 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_erase__SWIG_1(PyObject *self, Py_ssi
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_erase" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_erase" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t_erase" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T_erase" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t_erase" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T_erase" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
     }
   }
   res3 = SWIG_ConvertPtr(swig_obj[2], SWIG_as_voidptrptr(&iter3), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res3) || !iter3) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t_erase" "', argument " "3"" of type '" "std::vector< std::complex< double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T_erase" "', argument " "3"" of type '" "std::vector< std::complex< double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *>(iter3);
     if (iter_t) {
       arg3 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t_erase" "', argument " "3"" of type '" "std::vector< std::complex< double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T_erase" "', argument " "3"" of type '" "std::vector< std::complex< double > >::iterator""'");
     }
   }
   result = std_vector_Sl_std_complex_Sl_double_Sg__Sg__erase__SWIG_1(arg1,SWIG_STD_MOVE(arg2),SWIG_STD_MOVE(arg3));
@@ -19589,13 +19589,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_erase(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_erase(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_t_erase", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_T_erase", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -19606,7 +19606,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_erase(PyObject *self, PyObject *args
       int res = SWIG_ConvertPtr(argv[1], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
       _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *>(iter) != 0));
       if (_v) {
-        return _wrap_vector_complex_t_erase__SWIG_0(self, argc, argv);
+        return _wrap_vector_complex_T_erase__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -19623,14 +19623,14 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_erase(PyObject *self, PyObject *args
         int res = SWIG_ConvertPtr(argv[2], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
         _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *>(iter) != 0));
         if (_v) {
-          return _wrap_vector_complex_t_erase__SWIG_1(self, argc, argv);
+          return _wrap_vector_complex_T_erase__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_t_erase'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_T_erase'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::complex< double > >::erase(std::vector< std::complex< double > >::iterator)\n"
     "    std::vector< std::complex< double > >::erase(std::vector< std::complex< double > >::iterator,std::vector< std::complex< double > >::iterator)\n");
@@ -19638,7 +19638,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_complex_t__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_complex_T__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > >::size_type arg1 ;
   std::vector< std::complex< double > >::value_type *arg2 = 0 ;
@@ -19653,12 +19653,12 @@ SWIGINTERN PyObject *_wrap_new_vector_complex_t__SWIG_3(PyObject *self, Py_ssize
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_complex_t" "', argument " "1"" of type '" "std::vector< std::complex< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_complex_T" "', argument " "1"" of type '" "std::vector< std::complex< double > >::size_type""'");
   } 
   arg1 = static_cast< std::vector< std::complex< double > >::size_type >(val1);
   ecode2 = SWIG_AsVal_std_complex_Sl_double_Sg_(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "new_vector_complex_t" "', argument " "2"" of type '" "std::vector< std::complex< double > >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "new_vector_complex_T" "', argument " "2"" of type '" "std::vector< std::complex< double > >::value_type""'");
   } 
   temp2 = static_cast< std::vector< std::complex< double > >::value_type >(val2);
   arg2 = &temp2;
@@ -19670,16 +19670,16 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_complex_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_new_vector_complex_T(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vector_complex_t", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vector_complex_T", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 0) {
-    return _wrap_new_vector_complex_t__SWIG_0(self, argc, argv);
+    return _wrap_new_vector_complex_T__SWIG_0(self, argc, argv);
   }
   if (argc == 1) {
     int _v = 0;
@@ -19688,7 +19688,7 @@ SWIGINTERN PyObject *_wrap_new_vector_complex_t(PyObject *self, PyObject *args)
       _v = SWIG_CheckState(res);
     }
     if (_v) {
-      return _wrap_new_vector_complex_t__SWIG_2(self, argc, argv);
+      return _wrap_new_vector_complex_T__SWIG_2(self, argc, argv);
     }
   }
   if (argc == 1) {
@@ -19696,7 +19696,7 @@ SWIGINTERN PyObject *_wrap_new_vector_complex_t(PyObject *self, PyObject *args)
     int res = swig::asptr(argv[0], (std::vector< std::complex< double >,std::allocator< std::complex< double > > >**)(0));
     _v = SWIG_CheckState(res);
     if (_v) {
-      return _wrap_new_vector_complex_t__SWIG_1(self, argc, argv);
+      return _wrap_new_vector_complex_T__SWIG_1(self, argc, argv);
     }
   }
   if (argc == 2) {
@@ -19711,13 +19711,13 @@ SWIGINTERN PyObject *_wrap_new_vector_complex_t(PyObject *self, PyObject *args)
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_new_vector_complex_t__SWIG_3(self, argc, argv);
+        return _wrap_new_vector_complex_T__SWIG_3(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vector_complex_t'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vector_complex_T'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::complex< double > >::vector()\n"
     "    std::vector< std::complex< double > >::vector(std::vector< std::complex< double > > const &)\n"
@@ -19727,7 +19727,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_push_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_push_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::value_type *arg2 = 0 ;
@@ -19739,15 +19739,15 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_push_back(PyObject *self, PyObject *
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_complex_t_push_back", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_complex_T_push_back", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_push_back" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_push_back" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_std_complex_Sl_double_Sg_(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t_push_back" "', argument " "2"" of type '" "std::vector< std::complex< double > >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T_push_back" "', argument " "2"" of type '" "std::vector< std::complex< double > >::value_type""'");
   } 
   temp2 = static_cast< std::vector< std::complex< double > >::value_type >(val2);
   arg2 = &temp2;
@@ -19759,7 +19759,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_front(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_front(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -19772,7 +19772,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_front(PyObject *self, PyObject *args
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_front" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_front" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = (std::vector< std::complex< double > >::value_type *) &((std::vector< std::complex< double > > const *)arg1)->front();
@@ -19784,7 +19784,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -19797,7 +19797,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_back(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_back" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_back" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = (std::vector< std::complex< double > >::value_type *) &((std::vector< std::complex< double > > const *)arg1)->back();
@@ -19809,7 +19809,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_assign(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_assign(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::size_type arg2 ;
@@ -19824,20 +19824,20 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_assign(PyObject *self, PyObject *arg
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_complex_t_assign", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_complex_T_assign", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_assign" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_assign" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t_assign" "', argument " "2"" of type '" "std::vector< std::complex< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T_assign" "', argument " "2"" of type '" "std::vector< std::complex< double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::complex< double > >::size_type >(val2);
   ecode3 = SWIG_AsVal_std_complex_Sl_double_Sg_(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_t_assign" "', argument " "3"" of type '" "std::vector< std::complex< double > >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_T_assign" "', argument " "3"" of type '" "std::vector< std::complex< double > >::value_type""'");
   } 
   temp3 = static_cast< std::vector< std::complex< double > >::value_type >(val3);
   arg3 = &temp3;
@@ -19849,7 +19849,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::size_type arg2 ;
@@ -19866,17 +19866,17 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_resize__SWIG_1(PyObject *self, Py_ss
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_resize" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_resize" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t_resize" "', argument " "2"" of type '" "std::vector< std::complex< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T_resize" "', argument " "2"" of type '" "std::vector< std::complex< double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::complex< double > >::size_type >(val2);
   ecode3 = SWIG_AsVal_std_complex_Sl_double_Sg_(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_t_resize" "', argument " "3"" of type '" "std::vector< std::complex< double > >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_T_resize" "', argument " "3"" of type '" "std::vector< std::complex< double > >::value_type""'");
   } 
   temp3 = static_cast< std::vector< std::complex< double > >::value_type >(val3);
   arg3 = &temp3;
@@ -19888,13 +19888,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_resize(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_resize(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_t_resize", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_T_resize", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -19906,7 +19906,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_resize(PyObject *self, PyObject *arg
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_complex_t_resize__SWIG_0(self, argc, argv);
+        return _wrap_vector_complex_T_resize__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -19925,14 +19925,14 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_resize(PyObject *self, PyObject *arg
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_complex_t_resize__SWIG_1(self, argc, argv);
+          return _wrap_vector_complex_T_resize__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_t_resize'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_T_resize'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::complex< double > >::resize(std::vector< std::complex< double > >::size_type)\n"
     "    std::vector< std::complex< double > >::resize(std::vector< std::complex< double > >::size_type,std::vector< std::complex< double > >::value_type const &)\n");
@@ -19940,7 +19940,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::iterator arg2 ;
@@ -19958,23 +19958,23 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_insert__SWIG_0(PyObject *self, Py_ss
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_insert" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_insert" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t_insert" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T_insert" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t_insert" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T_insert" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_std_complex_Sl_double_Sg_(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_t_insert" "', argument " "3"" of type '" "std::vector< std::complex< double > >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_T_insert" "', argument " "3"" of type '" "std::vector< std::complex< double > >::value_type""'");
   } 
   temp3 = static_cast< std::vector< std::complex< double > >::value_type >(val3);
   arg3 = &temp3;
@@ -19987,7 +19987,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::iterator arg2 ;
@@ -20007,28 +20007,28 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_insert__SWIG_1(PyObject *self, Py_ss
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_insert" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_insert" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t_insert" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T_insert" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t_insert" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T_insert" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_size_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_t_insert" "', argument " "3"" of type '" "std::vector< std::complex< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_T_insert" "', argument " "3"" of type '" "std::vector< std::complex< double > >::size_type""'");
   } 
   arg3 = static_cast< std::vector< std::complex< double > >::size_type >(val3);
   ecode4 = SWIG_AsVal_std_complex_Sl_double_Sg_(swig_obj[3], &val4);
   if (!SWIG_IsOK(ecode4)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode4), "in method '" "vector_complex_t_insert" "', argument " "4"" of type '" "std::vector< std::complex< double > >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode4), "in method '" "vector_complex_T_insert" "', argument " "4"" of type '" "std::vector< std::complex< double > >::value_type""'");
   } 
   temp4 = static_cast< std::vector< std::complex< double > >::value_type >(val4);
   arg4 = &temp4;
@@ -20040,13 +20040,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_insert(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_insert(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_t_insert", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_T_insert", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -20062,7 +20062,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_insert(PyObject *self, PyObject *arg
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_complex_t_insert__SWIG_0(self, argc, argv);
+          return _wrap_vector_complex_T_insert__SWIG_0(self, argc, argv);
         }
       }
     }
@@ -20086,7 +20086,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_insert(PyObject *self, PyObject *arg
             _v = SWIG_CheckState(res);
           }
           if (_v) {
-            return _wrap_vector_complex_t_insert__SWIG_1(self, argc, argv);
+            return _wrap_vector_complex_T_insert__SWIG_1(self, argc, argv);
           }
         }
       }
@@ -20094,7 +20094,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_insert(PyObject *self, PyObject *arg
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_t_insert'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_T_insert'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::complex< double > >::insert(std::vector< std::complex< double > >::iterator,std::vector< std::complex< double > >::value_type const &)\n"
     "    std::vector< std::complex< double > >::insert(std::vector< std::complex< double > >::iterator,std::vector< std::complex< double > >::size_type,std::vector< std::complex< double > >::value_type const &)\n");
@@ -20102,7 +20102,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_reserve(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_reserve(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::size_type arg2 ;
@@ -20113,15 +20113,15 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_reserve(PyObject *self, PyObject *ar
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_complex_t_reserve", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_complex_T_reserve", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_reserve" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_reserve" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t_reserve" "', argument " "2"" of type '" "std::vector< std::complex< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T_reserve" "', argument " "2"" of type '" "std::vector< std::complex< double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::complex< double > >::size_type >(val2);
   (arg1)->reserve(arg2);
@@ -20132,7 +20132,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_capacity(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_capacity(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -20145,7 +20145,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_capacity(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_capacity" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_capacity" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = ((std::vector< std::complex< double > > const *)arg1)->capacity();
@@ -20156,7 +20156,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_delete_vector_complex_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_delete_vector_complex_T(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -20168,7 +20168,7 @@ SWIGINTERN PyObject *_wrap_delete_vector_complex_t(PyObject *self, PyObject *arg
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, SWIG_POINTER_DISOWN |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vector_complex_t" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vector_complex_T" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   {
@@ -20189,18 +20189,18 @@ fail:
 }
 
 
-SWIGINTERN PyObject *vector_complex_t_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vector_complex_T_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   PyObject *obj;
   if (!SWIG_Python_UnpackTuple(args, "swigregister", 1, 1, &obj)) return NULL;
   SWIG_TypeNewClientData(SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, SWIG_NewClientData(obj));
   return SWIG_Py_Void();
 }
 
-SWIGINTERN PyObject *vector_complex_t_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vector_complex_T_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   return SWIG_Python_InitShadowInstance(args);
 }
 
-SWIGINTERN PyObject *_wrap_vector_string_t_iterator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_iterator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   PyObject **arg2 = (PyObject **) 0 ;
@@ -20215,7 +20215,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_iterator(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_iterator" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_iterator" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = (swig::SwigPyIterator *)std_vector_Sl_std_string_Sg__iterator(arg1,arg2);
@@ -20226,7 +20226,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___nonzero__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T___nonzero__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -20239,7 +20239,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t___nonzero__(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___nonzero__" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___nonzero__" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = (bool)std_vector_Sl_std_string_Sg____nonzero__((std::vector< std::string > const *)arg1);
@@ -20250,7 +20250,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___bool__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T___bool__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -20263,7 +20263,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t___bool__(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___bool__" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___bool__" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = (bool)std_vector_Sl_std_string_Sg____bool__((std::vector< std::string > const *)arg1);
@@ -20274,7 +20274,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___len__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T___len__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -20287,7 +20287,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t___len__(PyObject *self, PyObject *arg
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___len__" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___len__" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = std_vector_Sl_std_string_Sg____len__((std::vector< std::string > const *)arg1);
@@ -20298,7 +20298,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___getslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T___getslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::difference_type arg2 ;
@@ -20313,20 +20313,20 @@ SWIGINTERN PyObject *_wrap_vector_string_t___getslice__(PyObject *self, PyObject
   std::vector< std::string,std::allocator< std::string > > *result = 0 ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_string_t___getslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_string_T___getslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___getslice__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___getslice__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_t___getslice__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_T___getslice__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::string >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_string_t___getslice__" "', argument " "3"" of type '" "std::vector< std::string >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_string_T___getslice__" "', argument " "3"" of type '" "std::vector< std::string >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::string >::difference_type >(val3);
   try {
@@ -20343,7 +20343,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::difference_type arg2 ;
@@ -20359,17 +20359,17 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setslice____SWIG_0(PyObject *self,
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___setslice__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___setslice__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_t___setslice__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_T___setslice__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::string >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_string_t___setslice__" "', argument " "3"" of type '" "std::vector< std::string >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_string_T___setslice__" "', argument " "3"" of type '" "std::vector< std::string >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::string >::difference_type >(val3);
   try {
@@ -20386,7 +20386,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::difference_type arg2 ;
@@ -20404,27 +20404,27 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setslice____SWIG_1(PyObject *self,
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___setslice__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___setslice__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_t___setslice__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_T___setslice__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::string >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_string_t___setslice__" "', argument " "3"" of type '" "std::vector< std::string >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_string_T___setslice__" "', argument " "3"" of type '" "std::vector< std::string >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::string >::difference_type >(val3);
   {
     std::vector< std::string,std::allocator< std::string > > *ptr = (std::vector< std::string,std::allocator< std::string > > *)0;
     res4 = swig::asptr(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_string_t___setslice__" "', argument " "4"" of type '" "std::vector< std::string,std::allocator< std::string > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_string_T___setslice__" "', argument " "4"" of type '" "std::vector< std::string,std::allocator< std::string > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_t___setslice__" "', argument " "4"" of type '" "std::vector< std::string,std::allocator< std::string > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_T___setslice__" "', argument " "4"" of type '" "std::vector< std::string,std::allocator< std::string > > const &""'"); 
     }
     arg4 = ptr;
   }
@@ -20444,13 +20444,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___setslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T___setslice__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_t___setslice__", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_T___setslice__", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -20467,7 +20467,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setslice__(PyObject *self, PyObject
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_string_t___setslice____SWIG_0(self, argc, argv);
+          return _wrap_vector_string_T___setslice____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -20490,7 +20490,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setslice__(PyObject *self, PyObject
           int res = swig::asptr(argv[3], (std::vector< std::string,std::allocator< std::string > >**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vector_string_t___setslice____SWIG_1(self, argc, argv);
+            return _wrap_vector_string_T___setslice____SWIG_1(self, argc, argv);
           }
         }
       }
@@ -20498,7 +20498,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setslice__(PyObject *self, PyObject
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_t___setslice__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_T___setslice__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::string >::__setslice__(std::vector< std::string >::difference_type,std::vector< std::string >::difference_type)\n"
     "    std::vector< std::string >::__setslice__(std::vector< std::string >::difference_type,std::vector< std::string >::difference_type,std::vector< std::string,std::allocator< std::string > > const &)\n");
@@ -20506,7 +20506,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___delslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T___delslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::difference_type arg2 ;
@@ -20520,20 +20520,20 @@ SWIGINTERN PyObject *_wrap_vector_string_t___delslice__(PyObject *self, PyObject
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_string_t___delslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_string_T___delslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___delslice__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___delslice__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_t___delslice__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_T___delslice__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::string >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_string_t___delslice__" "', argument " "3"" of type '" "std::vector< std::string >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_string_T___delslice__" "', argument " "3"" of type '" "std::vector< std::string >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::string >::difference_type >(val3);
   try {
@@ -20550,7 +20550,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::difference_type arg2 ;
@@ -20563,12 +20563,12 @@ SWIGINTERN PyObject *_wrap_vector_string_t___delitem____SWIG_0(PyObject *self, P
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___delitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___delitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_t___delitem__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_T___delitem__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::string >::difference_type >(val2);
   try {
@@ -20585,7 +20585,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -20597,12 +20597,12 @@ SWIGINTERN PyObject *_wrap_vector_string_t___getitem____SWIG_0(PyObject *self, P
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___getitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___getitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -20620,7 +20620,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -20633,12 +20633,12 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setitem____SWIG_0(PyObject *self, P
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___setitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___setitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -20646,10 +20646,10 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setitem____SWIG_0(PyObject *self, P
     std::vector< std::string,std::allocator< std::string > > *ptr = (std::vector< std::string,std::allocator< std::string > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_string_t___setitem__" "', argument " "3"" of type '" "std::vector< std::string,std::allocator< std::string > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_string_T___setitem__" "', argument " "3"" of type '" "std::vector< std::string,std::allocator< std::string > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_t___setitem__" "', argument " "3"" of type '" "std::vector< std::string,std::allocator< std::string > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_T___setitem__" "', argument " "3"" of type '" "std::vector< std::string,std::allocator< std::string > > const &""'"); 
     }
     arg3 = ptr;
   }
@@ -20669,7 +20669,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -20680,12 +20680,12 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setitem____SWIG_1(PyObject *self, P
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___setitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___setitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -20703,7 +20703,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -20714,12 +20714,12 @@ SWIGINTERN PyObject *_wrap_vector_string_t___delitem____SWIG_1(PyObject *self, P
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___delitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___delitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -20737,13 +20737,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___delitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T___delitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_t___delitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_T___delitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -20754,7 +20754,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t___delitem__(PyObject *self, PyObject
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_string_t___delitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_string_T___delitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -20768,13 +20768,13 @@ SWIGINTERN PyObject *_wrap_vector_string_t___delitem__(PyObject *self, PyObject
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_string_t___delitem____SWIG_0(self, argc, argv);
+        return _wrap_vector_string_T___delitem____SWIG_0(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_t___delitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_T___delitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::string >::__delitem__(std::vector< std::string >::difference_type)\n"
     "    std::vector< std::string >::__delitem__(SWIGPY_SLICEOBJECT *)\n");
@@ -20782,7 +20782,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::difference_type arg2 ;
@@ -20796,12 +20796,12 @@ SWIGINTERN PyObject *_wrap_vector_string_t___getitem____SWIG_1(PyObject *self, P
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___getitem__" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___getitem__" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_t___getitem__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_T___getitem__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::string >::difference_type >(val2);
   try {
@@ -20817,13 +20817,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___getitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T___getitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_t___getitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_T___getitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -20834,7 +20834,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t___getitem__(PyObject *self, PyObject
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_string_t___getitem____SWIG_0(self, argc, argv);
+        return _wrap_vector_string_T___getitem____SWIG_0(self, argc, argv);
       }
     }
   }
@@ -20848,13 +20848,13 @@ SWIGINTERN PyObject *_wrap_vector_string_t___getitem__(PyObject *self, PyObject
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_string_t___getitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_string_T___getitem____SWIG_1(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_t___getitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_T___getitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::string >::__getitem__(SWIGPY_SLICEOBJECT *)\n"
     "    std::vector< std::string >::__getitem__(std::vector< std::string >::difference_type) const\n");
@@ -20862,7 +20862,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::difference_type arg2 ;
@@ -20877,22 +20877,22 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setitem____SWIG_2(PyObject *self, P
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___setitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___setitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_t___setitem__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_T___setitem__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::string >::difference_type >(val2);
   {
     std::string *ptr = (std::string *)0;
     res3 = SWIG_AsPtr_std_string(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_string_t___setitem__" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_string_T___setitem__" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_t___setitem__" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_T___setitem__" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -20910,13 +20910,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___setitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T___setitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_t___setitem__", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_T___setitem__", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -20927,7 +20927,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setitem__(PyObject *self, PyObject
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_string_t___setitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_string_T___setitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -20943,7 +20943,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setitem__(PyObject *self, PyObject
         int res = swig::asptr(argv[2], (std::vector< std::string,std::allocator< std::string > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vector_string_t___setitem____SWIG_0(self, argc, argv);
+          return _wrap_vector_string_T___setitem____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -20961,14 +20961,14 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setitem__(PyObject *self, PyObject
         int res = SWIG_AsPtr_std_string(argv[2], (std::string**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vector_string_t___setitem____SWIG_2(self, argc, argv);
+          return _wrap_vector_string_T___setitem____SWIG_2(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_t___setitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_T___setitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::string >::__setitem__(SWIGPY_SLICEOBJECT *,std::vector< std::string,std::allocator< std::string > > const &)\n"
     "    std::vector< std::string >::__setitem__(SWIGPY_SLICEOBJECT *)\n"
@@ -20977,7 +20977,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_pop(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_pop(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -20990,7 +20990,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_pop(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_pop" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_pop" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   try {
@@ -21005,7 +21005,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_append(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_append(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::value_type *arg2 = 0 ;
@@ -21015,20 +21015,20 @@ SWIGINTERN PyObject *_wrap_vector_string_t_append(PyObject *self, PyObject *args
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_string_t_append", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_string_T_append", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_append" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_append" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_string_t_append" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_string_T_append" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_t_append" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_T_append" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -21042,7 +21042,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_string_t__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
+SWIGINTERN PyObject *_wrap_new_vector_string_T__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
   PyObject *resultobj = 0;
   std::vector< std::string > *result = 0 ;
   
@@ -21056,7 +21056,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_string_t__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_string_T__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = 0 ;
   int res1 = SWIG_OLDOBJ ;
@@ -21068,10 +21068,10 @@ SWIGINTERN PyObject *_wrap_new_vector_string_t__SWIG_1(PyObject *self, Py_ssize_
     std::vector< std::string,std::allocator< std::string > > *ptr = (std::vector< std::string,std::allocator< std::string > > *)0;
     res1 = swig::asptr(swig_obj[0], &ptr);
     if (!SWIG_IsOK(res1)) {
-      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vector_string_t" "', argument " "1"" of type '" "std::vector< std::string > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vector_string_T" "', argument " "1"" of type '" "std::vector< std::string > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_string_t" "', argument " "1"" of type '" "std::vector< std::string > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_string_T" "', argument " "1"" of type '" "std::vector< std::string > const &""'"); 
     }
     arg1 = ptr;
   }
@@ -21085,7 +21085,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_empty(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_empty(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -21098,7 +21098,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_empty(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_empty" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_empty" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = (bool)((std::vector< std::string > const *)arg1)->empty();
@@ -21109,7 +21109,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_size(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_size(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -21122,7 +21122,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_size(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_size" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_size" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = ((std::vector< std::string > const *)arg1)->size();
@@ -21133,7 +21133,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_swap(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_swap(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string > *arg2 = 0 ;
@@ -21144,18 +21144,18 @@ SWIGINTERN PyObject *_wrap_vector_string_t_swap(PyObject *self, PyObject *args)
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_string_t_swap", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_string_T_swap", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_swap" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_swap" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], &argp2, SWIGTYPE_p_std__vectorT_std__string_t,  0 );
   if (!SWIG_IsOK(res2)) {
-    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_string_t_swap" "', argument " "2"" of type '" "std::vector< std::string > &""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_string_T_swap" "', argument " "2"" of type '" "std::vector< std::string > &""'"); 
   }
   if (!argp2) {
-    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_t_swap" "', argument " "2"" of type '" "std::vector< std::string > &""'"); 
+    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_T_swap" "', argument " "2"" of type '" "std::vector< std::string > &""'"); 
   }
   arg2 = reinterpret_cast< std::vector< std::string > * >(argp2);
   (arg1)->swap(*arg2);
@@ -21166,7 +21166,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_begin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_begin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -21179,7 +21179,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_begin(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_begin" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_begin" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = (arg1)->begin();
@@ -21191,7 +21191,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_end(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_end(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -21204,7 +21204,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_end(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_end" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_end" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = (arg1)->end();
@@ -21216,7 +21216,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_rbegin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_rbegin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -21229,7 +21229,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_rbegin(PyObject *self, PyObject *args
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_rbegin" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_rbegin" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = (arg1)->rbegin();
@@ -21241,7 +21241,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_rend(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_rend(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -21254,7 +21254,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_rend(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_rend" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_rend" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = (arg1)->rend();
@@ -21266,7 +21266,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_clear(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_clear(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -21278,7 +21278,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_clear(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_clear" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_clear" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   (arg1)->clear();
@@ -21289,7 +21289,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_get_allocator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_get_allocator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -21302,7 +21302,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_get_allocator(PyObject *self, PyObjec
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_get_allocator" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_get_allocator" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = ((std::vector< std::string > const *)arg1)->get_allocator();
@@ -21313,7 +21313,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_string_t__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_string_T__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string >::size_type arg1 ;
   size_t val1 ;
@@ -21324,7 +21324,7 @@ SWIGINTERN PyObject *_wrap_new_vector_string_t__SWIG_2(PyObject *self, Py_ssize_
   if ((nobjs < 1) || (nobjs > 1)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_string_t" "', argument " "1"" of type '" "std::vector< std::string >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_string_T" "', argument " "1"" of type '" "std::vector< std::string >::size_type""'");
   } 
   arg1 = static_cast< std::vector< std::string >::size_type >(val1);
   result = (std::vector< std::string > *)new std::vector< std::string >(arg1);
@@ -21335,7 +21335,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_pop_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_pop_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -21347,7 +21347,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_pop_back(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_pop_back" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_pop_back" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   (arg1)->pop_back();
@@ -21358,7 +21358,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::size_type arg2 ;
@@ -21371,12 +21371,12 @@ SWIGINTERN PyObject *_wrap_vector_string_t_resize__SWIG_0(PyObject *self, Py_ssi
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_resize" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_resize" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_t_resize" "', argument " "2"" of type '" "std::vector< std::string >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_T_resize" "', argument " "2"" of type '" "std::vector< std::string >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::string >::size_type >(val2);
   (arg1)->resize(arg2);
@@ -21387,7 +21387,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::iterator arg2 ;
@@ -21401,18 +21401,18 @@ SWIGINTERN PyObject *_wrap_vector_string_t_erase__SWIG_0(PyObject *self, Py_ssiz
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_erase" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_erase" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t_erase" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T_erase" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::string >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::string >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t_erase" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T_erase" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
     }
   }
   result = std_vector_Sl_std_string_Sg__erase__SWIG_0(arg1,SWIG_STD_MOVE(arg2));
@@ -21424,7 +21424,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::iterator arg2 ;
@@ -21441,29 +21441,29 @@ SWIGINTERN PyObject *_wrap_vector_string_t_erase__SWIG_1(PyObject *self, Py_ssiz
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_erase" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_erase" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t_erase" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T_erase" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::string >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::string >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t_erase" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T_erase" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
     }
   }
   res3 = SWIG_ConvertPtr(swig_obj[2], SWIG_as_voidptrptr(&iter3), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res3) || !iter3) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t_erase" "', argument " "3"" of type '" "std::vector< std::string >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T_erase" "', argument " "3"" of type '" "std::vector< std::string >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::string >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::string >::iterator > *>(iter3);
     if (iter_t) {
       arg3 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t_erase" "', argument " "3"" of type '" "std::vector< std::string >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T_erase" "', argument " "3"" of type '" "std::vector< std::string >::iterator""'");
     }
   }
   result = std_vector_Sl_std_string_Sg__erase__SWIG_1(arg1,SWIG_STD_MOVE(arg2),SWIG_STD_MOVE(arg3));
@@ -21475,13 +21475,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_erase(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_erase(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_t_erase", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_T_erase", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -21492,7 +21492,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_erase(PyObject *self, PyObject *args)
       int res = SWIG_ConvertPtr(argv[1], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
       _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< std::string >::iterator > *>(iter) != 0));
       if (_v) {
-        return _wrap_vector_string_t_erase__SWIG_0(self, argc, argv);
+        return _wrap_vector_string_T_erase__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -21509,14 +21509,14 @@ SWIGINTERN PyObject *_wrap_vector_string_t_erase(PyObject *self, PyObject *args)
         int res = SWIG_ConvertPtr(argv[2], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
         _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< std::string >::iterator > *>(iter) != 0));
         if (_v) {
-          return _wrap_vector_string_t_erase__SWIG_1(self, argc, argv);
+          return _wrap_vector_string_T_erase__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_t_erase'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_T_erase'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::string >::erase(std::vector< std::string >::iterator)\n"
     "    std::vector< std::string >::erase(std::vector< std::string >::iterator,std::vector< std::string >::iterator)\n");
@@ -21524,7 +21524,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_string_t__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_string_T__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string >::size_type arg1 ;
   std::vector< std::string >::value_type *arg2 = 0 ;
@@ -21537,17 +21537,17 @@ SWIGINTERN PyObject *_wrap_new_vector_string_t__SWIG_3(PyObject *self, Py_ssize_
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_string_t" "', argument " "1"" of type '" "std::vector< std::string >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_string_T" "', argument " "1"" of type '" "std::vector< std::string >::size_type""'");
   } 
   arg1 = static_cast< std::vector< std::string >::size_type >(val1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "new_vector_string_t" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "new_vector_string_T" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_string_t" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_string_T" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -21561,16 +21561,16 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_string_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_new_vector_string_T(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vector_string_t", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vector_string_T", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 0) {
-    return _wrap_new_vector_string_t__SWIG_0(self, argc, argv);
+    return _wrap_new_vector_string_T__SWIG_0(self, argc, argv);
   }
   if (argc == 1) {
     int _v = 0;
@@ -21579,7 +21579,7 @@ SWIGINTERN PyObject *_wrap_new_vector_string_t(PyObject *self, PyObject *args) {
       _v = SWIG_CheckState(res);
     }
     if (_v) {
-      return _wrap_new_vector_string_t__SWIG_2(self, argc, argv);
+      return _wrap_new_vector_string_T__SWIG_2(self, argc, argv);
     }
   }
   if (argc == 1) {
@@ -21587,7 +21587,7 @@ SWIGINTERN PyObject *_wrap_new_vector_string_t(PyObject *self, PyObject *args) {
     int res = swig::asptr(argv[0], (std::vector< std::string,std::allocator< std::string > >**)(0));
     _v = SWIG_CheckState(res);
     if (_v) {
-      return _wrap_new_vector_string_t__SWIG_1(self, argc, argv);
+      return _wrap_new_vector_string_T__SWIG_1(self, argc, argv);
     }
   }
   if (argc == 2) {
@@ -21600,13 +21600,13 @@ SWIGINTERN PyObject *_wrap_new_vector_string_t(PyObject *self, PyObject *args) {
       int res = SWIG_AsPtr_std_string(argv[1], (std::string**)(0));
       _v = SWIG_CheckState(res);
       if (_v) {
-        return _wrap_new_vector_string_t__SWIG_3(self, argc, argv);
+        return _wrap_new_vector_string_T__SWIG_3(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vector_string_t'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vector_string_T'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::string >::vector()\n"
     "    std::vector< std::string >::vector(std::vector< std::string > const &)\n"
@@ -21616,7 +21616,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_push_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_push_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::value_type *arg2 = 0 ;
@@ -21626,20 +21626,20 @@ SWIGINTERN PyObject *_wrap_vector_string_t_push_back(PyObject *self, PyObject *a
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_string_t_push_back", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_string_T_push_back", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_push_back" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_push_back" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_string_t_push_back" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_string_T_push_back" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_t_push_back" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_T_push_back" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -21653,7 +21653,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_front(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_front(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -21666,7 +21666,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_front(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_front" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_front" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = (std::vector< std::string >::value_type *) &((std::vector< std::string > const *)arg1)->front();
@@ -21678,7 +21678,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -21691,7 +21691,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_back(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_back" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_back" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = (std::vector< std::string >::value_type *) &((std::vector< std::string > const *)arg1)->back();
@@ -21703,7 +21703,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_assign(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_assign(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::size_type arg2 ;
@@ -21716,25 +21716,25 @@ SWIGINTERN PyObject *_wrap_vector_string_t_assign(PyObject *self, PyObject *args
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_string_t_assign", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_string_T_assign", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_assign" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_assign" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_t_assign" "', argument " "2"" of type '" "std::vector< std::string >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_T_assign" "', argument " "2"" of type '" "std::vector< std::string >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::string >::size_type >(val2);
   {
     std::string *ptr = (std::string *)0;
     res3 = SWIG_AsPtr_std_string(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_string_t_assign" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_string_T_assign" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_t_assign" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_T_assign" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -21748,7 +21748,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::size_type arg2 ;
@@ -21763,22 +21763,22 @@ SWIGINTERN PyObject *_wrap_vector_string_t_resize__SWIG_1(PyObject *self, Py_ssi
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_resize" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_resize" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_t_resize" "', argument " "2"" of type '" "std::vector< std::string >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_T_resize" "', argument " "2"" of type '" "std::vector< std::string >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::string >::size_type >(val2);
   {
     std::string *ptr = (std::string *)0;
     res3 = SWIG_AsPtr_std_string(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_string_t_resize" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_string_T_resize" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_t_resize" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_T_resize" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -21792,13 +21792,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_resize(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_resize(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_t_resize", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_T_resize", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -21810,7 +21810,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_resize(PyObject *self, PyObject *args
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_string_t_resize__SWIG_0(self, argc, argv);
+        return _wrap_vector_string_T_resize__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -21827,14 +21827,14 @@ SWIGINTERN PyObject *_wrap_vector_string_t_resize(PyObject *self, PyObject *args
         int res = SWIG_AsPtr_std_string(argv[2], (std::string**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vector_string_t_resize__SWIG_1(self, argc, argv);
+          return _wrap_vector_string_T_resize__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_t_resize'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_T_resize'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::string >::resize(std::vector< std::string >::size_type)\n"
     "    std::vector< std::string >::resize(std::vector< std::string >::size_type,std::vector< std::string >::value_type const &)\n");
@@ -21842,7 +21842,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::iterator arg2 ;
@@ -21858,28 +21858,28 @@ SWIGINTERN PyObject *_wrap_vector_string_t_insert__SWIG_0(PyObject *self, Py_ssi
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_insert" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_insert" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t_insert" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T_insert" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::string >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::string >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t_insert" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T_insert" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
     }
   }
   {
     std::string *ptr = (std::string *)0;
     res3 = SWIG_AsPtr_std_string(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_string_t_insert" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_string_T_insert" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_t_insert" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_T_insert" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -21894,7 +21894,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::iterator arg2 ;
@@ -21912,33 +21912,33 @@ SWIGINTERN PyObject *_wrap_vector_string_t_insert__SWIG_1(PyObject *self, Py_ssi
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_insert" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_insert" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t_insert" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T_insert" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::string >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::string >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t_insert" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T_insert" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_size_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_string_t_insert" "', argument " "3"" of type '" "std::vector< std::string >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_string_T_insert" "', argument " "3"" of type '" "std::vector< std::string >::size_type""'");
   } 
   arg3 = static_cast< std::vector< std::string >::size_type >(val3);
   {
     std::string *ptr = (std::string *)0;
     res4 = SWIG_AsPtr_std_string(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_string_t_insert" "', argument " "4"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_string_T_insert" "', argument " "4"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_t_insert" "', argument " "4"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_T_insert" "', argument " "4"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     arg4 = ptr;
   }
@@ -21952,13 +21952,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_insert(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_insert(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_t_insert", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_T_insert", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -21972,7 +21972,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_insert(PyObject *self, PyObject *args
         int res = SWIG_AsPtr_std_string(argv[2], (std::string**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vector_string_t_insert__SWIG_0(self, argc, argv);
+          return _wrap_vector_string_T_insert__SWIG_0(self, argc, argv);
         }
       }
     }
@@ -21994,7 +21994,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_insert(PyObject *self, PyObject *args
           int res = SWIG_AsPtr_std_string(argv[3], (std::string**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vector_string_t_insert__SWIG_1(self, argc, argv);
+            return _wrap_vector_string_T_insert__SWIG_1(self, argc, argv);
           }
         }
       }
@@ -22002,7 +22002,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_insert(PyObject *self, PyObject *args
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_t_insert'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_T_insert'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::string >::insert(std::vector< std::string >::iterator,std::vector< std::string >::value_type const &)\n"
     "    std::vector< std::string >::insert(std::vector< std::string >::iterator,std::vector< std::string >::size_type,std::vector< std::string >::value_type const &)\n");
@@ -22010,7 +22010,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_reserve(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_reserve(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::size_type arg2 ;
@@ -22021,15 +22021,15 @@ SWIGINTERN PyObject *_wrap_vector_string_t_reserve(PyObject *self, PyObject *arg
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_string_t_reserve", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_string_T_reserve", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_reserve" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_reserve" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_t_reserve" "', argument " "2"" of type '" "std::vector< std::string >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_T_reserve" "', argument " "2"" of type '" "std::vector< std::string >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::string >::size_type >(val2);
   (arg1)->reserve(arg2);
@@ -22040,7 +22040,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_capacity(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_capacity(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -22053,7 +22053,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_capacity(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_capacity" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_capacity" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = ((std::vector< std::string > const *)arg1)->capacity();
@@ -22064,7 +22064,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_delete_vector_string_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_delete_vector_string_T(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -22076,7 +22076,7 @@ SWIGINTERN PyObject *_wrap_delete_vector_string_t(PyObject *self, PyObject *args
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, SWIG_POINTER_DISOWN |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vector_string_t" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vector_string_T" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   {
@@ -22097,18 +22097,18 @@ fail:
 }
 
 
-SWIGINTERN PyObject *vector_string_t_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vector_string_T_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   PyObject *obj;
   if (!SWIG_Python_UnpackTuple(args, "swigregister", 1, 1, &obj)) return NULL;
   SWIG_TypeNewClientData(SWIGTYPE_p_std__vectorT_std__string_t, SWIG_NewClientData(obj));
   return SWIG_Py_Void();
 }
 
-SWIGINTERN PyObject *vector_string_t_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vector_string_T_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   return SWIG_Python_InitShadowInstance(args);
 }
 
-SWIGINTERN PyObject *_wrap_new_map_string_double_t__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_map_string_double_T__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::less< std::string > *arg1 = 0 ;
   void *argp1 = 0 ;
@@ -22119,10 +22119,10 @@ SWIGINTERN PyObject *_wrap_new_map_string_double_t__SWIG_0(PyObject *self, Py_ss
   if ((nobjs < 1) || (nobjs > 1)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1, SWIGTYPE_p_std__lessT_std__string_t,  0  | 0);
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_map_string_double_t" "', argument " "1"" of type '" "std::less< std::string > const &""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_map_string_double_T" "', argument " "1"" of type '" "std::less< std::string > const &""'"); 
   }
   if (!argp1) {
-    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_map_string_double_t" "', argument " "1"" of type '" "std::less< std::string > const &""'"); 
+    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_map_string_double_T" "', argument " "1"" of type '" "std::less< std::string > const &""'"); 
   }
   arg1 = reinterpret_cast< std::less< std::string > * >(argp1);
   result = (std::map< std::string,double > *)new std::map< std::string,double >((std::less< std::string > const &)*arg1);
@@ -22133,7 +22133,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_iterator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_iterator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   PyObject **arg2 = (PyObject **) 0 ;
@@ -22148,7 +22148,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_iterator(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_iterator" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_iterator" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (swig::SwigPyIterator *)std_map_Sl_std_string_Sc_double_Sg__iterator(arg1,arg2);
@@ -22159,7 +22159,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t___nonzero__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T___nonzero__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -22172,7 +22172,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t___nonzero__(PyObject *self, PyObj
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t___nonzero__" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T___nonzero__" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (bool)std_map_Sl_std_string_Sc_double_Sg____nonzero__((std::map< std::string,double > const *)arg1);
@@ -22183,7 +22183,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t___bool__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T___bool__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -22196,7 +22196,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t___bool__(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t___bool__" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T___bool__" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (bool)std_map_Sl_std_string_Sc_double_Sg____bool__((std::map< std::string,double > const *)arg1);
@@ -22207,7 +22207,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t___len__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T___len__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -22220,7 +22220,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t___len__(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t___len__" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T___len__" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = std_map_Sl_std_string_Sc_double_Sg____len__((std::map< std::string,double > const *)arg1);
@@ -22231,7 +22231,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t___getitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T___getitem__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::key_type *arg2 = 0 ;
@@ -22242,20 +22242,20 @@ SWIGINTERN PyObject *_wrap_map_string_double_t___getitem__(PyObject *self, PyObj
   std::map< std::string,double >::mapped_type *result = 0 ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "map_string_double_t___getitem__", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "map_string_double_T___getitem__", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t___getitem__" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T___getitem__" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t___getitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T___getitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t___getitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T___getitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -22273,7 +22273,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t___delitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T___delitem__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::key_type *arg2 = 0 ;
@@ -22283,20 +22283,20 @@ SWIGINTERN PyObject *_wrap_map_string_double_t___delitem__(PyObject *self, PyObj
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "map_string_double_t___delitem__", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "map_string_double_T___delitem__", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t___delitem__" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T___delitem__" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t___delitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T___delitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t___delitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T___delitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -22314,7 +22314,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_has_key(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_has_key(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::key_type *arg2 = 0 ;
@@ -22325,20 +22325,20 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_has_key(PyObject *self, PyObject
   bool result;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "map_string_double_t_has_key", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "map_string_double_T_has_key", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_has_key" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_has_key" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t_has_key" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T_has_key" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t_has_key" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T_has_key" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -22352,7 +22352,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_keys(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_keys(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -22365,7 +22365,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_keys(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_keys" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_keys" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (PyObject *)std_map_Sl_std_string_Sc_double_Sg__keys(arg1);
@@ -22376,7 +22376,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_values(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_values(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -22389,7 +22389,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_values(PyObject *self, PyObject *
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_values" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_values" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (PyObject *)std_map_Sl_std_string_Sc_double_Sg__values(arg1);
@@ -22400,7 +22400,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_items(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_items(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -22413,7 +22413,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_items(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_items" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_items" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (PyObject *)std_map_Sl_std_string_Sc_double_Sg__items(arg1);
@@ -22424,7 +22424,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t___contains__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T___contains__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::key_type *arg2 = 0 ;
@@ -22435,20 +22435,20 @@ SWIGINTERN PyObject *_wrap_map_string_double_t___contains__(PyObject *self, PyOb
   bool result;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "map_string_double_t___contains__", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "map_string_double_T___contains__", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t___contains__" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T___contains__" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t___contains__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T___contains__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t___contains__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T___contains__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -22462,7 +22462,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_key_iterator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_key_iterator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   PyObject **arg2 = (PyObject **) 0 ;
@@ -22477,7 +22477,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_key_iterator(PyObject *self, PyOb
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_key_iterator" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_key_iterator" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (swig::SwigPyIterator *)std_map_Sl_std_string_Sc_double_Sg__key_iterator(arg1,arg2);
@@ -22488,7 +22488,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_value_iterator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_value_iterator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   PyObject **arg2 = (PyObject **) 0 ;
@@ -22503,7 +22503,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_value_iterator(PyObject *self, Py
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_value_iterator" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_value_iterator" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (swig::SwigPyIterator *)std_map_Sl_std_string_Sc_double_Sg__value_iterator(arg1,arg2);
@@ -22514,7 +22514,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_map_string_double_T___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::key_type *arg2 = 0 ;
@@ -22526,17 +22526,17 @@ SWIGINTERN PyObject *_wrap_map_string_double_t___setitem____SWIG_0(PyObject *sel
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t___setitem__" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T___setitem__" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t___setitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T___setitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t___setitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T___setitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -22550,7 +22550,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_map_string_double_T___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::key_type *arg2 = 0 ;
@@ -22566,23 +22566,23 @@ SWIGINTERN PyObject *_wrap_map_string_double_t___setitem____SWIG_1(PyObject *sel
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t___setitem__" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T___setitem__" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t___setitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T___setitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t___setitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T___setitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     arg2 = ptr;
   }
   ecode3 = SWIG_AsVal_double(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "map_string_double_t___setitem__" "', argument " "3"" of type '" "std::map< std::string,double >::mapped_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "map_string_double_T___setitem__" "', argument " "3"" of type '" "std::map< std::string,double >::mapped_type""'");
   } 
   temp3 = static_cast< std::map< std::string,double >::mapped_type >(val3);
   arg3 = &temp3;
@@ -22600,13 +22600,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t___setitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T___setitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "map_string_double_t___setitem__", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "map_string_double_T___setitem__", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -22616,7 +22616,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t___setitem__(PyObject *self, PyObj
       int res = SWIG_AsPtr_std_string(argv[1], (std::string**)(0));
       _v = SWIG_CheckState(res);
       if (_v) {
-        return _wrap_map_string_double_t___setitem____SWIG_0(self, argc, argv);
+        return _wrap_map_string_double_T___setitem____SWIG_0(self, argc, argv);
       }
     }
   }
@@ -22633,14 +22633,14 @@ SWIGINTERN PyObject *_wrap_map_string_double_t___setitem__(PyObject *self, PyObj
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_map_string_double_t___setitem____SWIG_1(self, argc, argv);
+          return _wrap_map_string_double_T___setitem____SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'map_string_double_t___setitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'map_string_double_T___setitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::map< std::string,double >::__setitem__(std::map< std::string,double >::key_type const &)\n"
     "    std::map< std::string,double >::__setitem__(std::map< std::string,double >::key_type const &,std::map< std::string,double >::mapped_type const &)\n");
@@ -22648,7 +22648,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_asdict(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_asdict(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -22661,7 +22661,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_asdict(PyObject *self, PyObject *
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_asdict" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_asdict" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (PyObject *)std_map_Sl_std_string_Sc_double_Sg__asdict(arg1);
@@ -22672,7 +22672,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_map_string_double_t__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
+SWIGINTERN PyObject *_wrap_new_map_string_double_T__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *result = 0 ;
   
@@ -22686,7 +22686,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_map_string_double_t__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_map_string_double_T__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = 0 ;
   int res1 = SWIG_OLDOBJ ;
@@ -22698,10 +22698,10 @@ SWIGINTERN PyObject *_wrap_new_map_string_double_t__SWIG_2(PyObject *self, Py_ss
     std::map< std::string,double,std::less< std::string >,std::allocator< std::pair< std::string const,double > > > *ptr = (std::map< std::string,double,std::less< std::string >,std::allocator< std::pair< std::string const,double > > > *)0;
     res1 = swig::asptr(swig_obj[0], &ptr);
     if (!SWIG_IsOK(res1)) {
-      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_map_string_double_t" "', argument " "1"" of type '" "std::map< std::string,double > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_map_string_double_T" "', argument " "1"" of type '" "std::map< std::string,double > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_map_string_double_t" "', argument " "1"" of type '" "std::map< std::string,double > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_map_string_double_T" "', argument " "1"" of type '" "std::map< std::string,double > const &""'"); 
     }
     arg1 = ptr;
   }
@@ -22715,23 +22715,23 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_map_string_double_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_new_map_string_double_T(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[2] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "new_map_string_double_t", 0, 1, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "new_map_string_double_T", 0, 1, argv))) SWIG_fail;
   --argc;
   if (argc == 0) {
-    return _wrap_new_map_string_double_t__SWIG_1(self, argc, argv);
+    return _wrap_new_map_string_double_T__SWIG_1(self, argc, argv);
   }
   if (argc == 1) {
     int _v = 0;
     int res = SWIG_ConvertPtr(argv[0], 0, SWIGTYPE_p_std__lessT_std__string_t, SWIG_POINTER_NO_NULL | 0);
     _v = SWIG_CheckState(res);
     if (_v) {
-      return _wrap_new_map_string_double_t__SWIG_0(self, argc, argv);
+      return _wrap_new_map_string_double_T__SWIG_0(self, argc, argv);
     }
   }
   if (argc == 1) {
@@ -22739,12 +22739,12 @@ SWIGINTERN PyObject *_wrap_new_map_string_double_t(PyObject *self, PyObject *arg
     int res = swig::asptr(argv[0], (std::map< std::string,double,std::less< std::string >,std::allocator< std::pair< std::string const,double > > >**)(0));
     _v = SWIG_CheckState(res);
     if (_v) {
-      return _wrap_new_map_string_double_t__SWIG_2(self, argc, argv);
+      return _wrap_new_map_string_double_T__SWIG_2(self, argc, argv);
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_map_string_double_t'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_map_string_double_T'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::map< std::string,double >::map(std::less< std::string > const &)\n"
     "    std::map< std::string,double >::map()\n"
@@ -22753,7 +22753,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_empty(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_empty(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -22766,7 +22766,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_empty(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_empty" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_empty" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (bool)((std::map< std::string,double > const *)arg1)->empty();
@@ -22777,7 +22777,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_size(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_size(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -22790,7 +22790,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_size(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_size" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_size" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = ((std::map< std::string,double > const *)arg1)->size();
@@ -22801,7 +22801,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_swap(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_swap(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double > *arg2 = 0 ;
@@ -22812,18 +22812,18 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_swap(PyObject *self, PyObject *ar
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "map_string_double_t_swap", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "map_string_double_T_swap", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_swap" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_swap" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], &argp2, SWIGTYPE_p_std__mapT_std__string_double_t,  0 );
   if (!SWIG_IsOK(res2)) {
-    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t_swap" "', argument " "2"" of type '" "std::map< std::string,double > &""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T_swap" "', argument " "2"" of type '" "std::map< std::string,double > &""'"); 
   }
   if (!argp2) {
-    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t_swap" "', argument " "2"" of type '" "std::map< std::string,double > &""'"); 
+    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T_swap" "', argument " "2"" of type '" "std::map< std::string,double > &""'"); 
   }
   arg2 = reinterpret_cast< std::map< std::string,double > * >(argp2);
   (arg1)->swap(*arg2);
@@ -22834,7 +22834,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_begin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_begin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -22847,7 +22847,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_begin(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_begin" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_begin" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (arg1)->begin();
@@ -22859,7 +22859,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_end(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_end(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -22872,7 +22872,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_end(PyObject *self, PyObject *arg
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_end" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_end" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (arg1)->end();
@@ -22884,7 +22884,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_rbegin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_rbegin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -22897,7 +22897,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_rbegin(PyObject *self, PyObject *
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_rbegin" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_rbegin" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (arg1)->rbegin();
@@ -22909,7 +22909,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_rend(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_rend(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -22922,7 +22922,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_rend(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_rend" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_rend" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (arg1)->rend();
@@ -22934,7 +22934,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_clear(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_clear(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -22946,7 +22946,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_clear(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_clear" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_clear" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   (arg1)->clear();
@@ -22957,7 +22957,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_get_allocator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_get_allocator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -22970,7 +22970,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_get_allocator(PyObject *self, PyO
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_get_allocator" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_get_allocator" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = ((std::map< std::string,double > const *)arg1)->get_allocator();
@@ -22981,7 +22981,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::key_type *arg2 = 0 ;
@@ -22994,17 +22994,17 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_erase__SWIG_0(PyObject *self, Py_
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_erase" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_erase" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t_erase" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T_erase" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t_erase" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T_erase" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -23018,7 +23018,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_count(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_count(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::key_type *arg2 = 0 ;
@@ -23029,20 +23029,20 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_count(PyObject *self, PyObject *a
   std::map< std::string,double >::size_type result;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "map_string_double_t_count", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "map_string_double_T_count", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_count" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_count" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t_count" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T_count" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t_count" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T_count" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -23056,7 +23056,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::iterator arg2 ;
@@ -23069,18 +23069,18 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_erase__SWIG_1(PyObject *self, Py_
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_erase" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_erase" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_t_erase" "', argument " "2"" of type '" "std::map< std::string,double >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_T_erase" "', argument " "2"" of type '" "std::map< std::string,double >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::map< std::string,double >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::map< std::string,double >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_t_erase" "', argument " "2"" of type '" "std::map< std::string,double >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_T_erase" "', argument " "2"" of type '" "std::map< std::string,double >::iterator""'");
     }
   }
   std_map_Sl_std_string_Sc_double_Sg__erase__SWIG_1(arg1,SWIG_STD_MOVE(arg2));
@@ -23091,7 +23091,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_erase__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_erase__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::iterator arg2 ;
@@ -23107,29 +23107,29 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_erase__SWIG_2(PyObject *self, Py_
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_erase" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_erase" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_t_erase" "', argument " "2"" of type '" "std::map< std::string,double >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_T_erase" "', argument " "2"" of type '" "std::map< std::string,double >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::map< std::string,double >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::map< std::string,double >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_t_erase" "', argument " "2"" of type '" "std::map< std::string,double >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_T_erase" "', argument " "2"" of type '" "std::map< std::string,double >::iterator""'");
     }
   }
   res3 = SWIG_ConvertPtr(swig_obj[2], SWIG_as_voidptrptr(&iter3), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res3) || !iter3) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_t_erase" "', argument " "3"" of type '" "std::map< std::string,double >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_T_erase" "', argument " "3"" of type '" "std::map< std::string,double >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::map< std::string,double >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::map< std::string,double >::iterator > *>(iter3);
     if (iter_t) {
       arg3 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_t_erase" "', argument " "3"" of type '" "std::map< std::string,double >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_T_erase" "', argument " "3"" of type '" "std::map< std::string,double >::iterator""'");
     }
   }
   std_map_Sl_std_string_Sc_double_Sg__erase__SWIG_2(arg1,SWIG_STD_MOVE(arg2),SWIG_STD_MOVE(arg3));
@@ -23140,13 +23140,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_erase(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_erase(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "map_string_double_t_erase", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "map_string_double_T_erase", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -23157,7 +23157,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_erase(PyObject *self, PyObject *a
       int res = SWIG_ConvertPtr(argv[1], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
       _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::map< std::string,double >::iterator > *>(iter) != 0));
       if (_v) {
-        return _wrap_map_string_double_t_erase__SWIG_1(self, argc, argv);
+        return _wrap_map_string_double_T_erase__SWIG_1(self, argc, argv);
       }
     }
   }
@@ -23169,7 +23169,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_erase(PyObject *self, PyObject *a
       int res = SWIG_AsPtr_std_string(argv[1], (std::string**)(0));
       _v = SWIG_CheckState(res);
       if (_v) {
-        return _wrap_map_string_double_t_erase__SWIG_0(self, argc, argv);
+        return _wrap_map_string_double_T_erase__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -23186,14 +23186,14 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_erase(PyObject *self, PyObject *a
         int res = SWIG_ConvertPtr(argv[2], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
         _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::map< std::string,double >::iterator > *>(iter) != 0));
         if (_v) {
-          return _wrap_map_string_double_t_erase__SWIG_2(self, argc, argv);
+          return _wrap_map_string_double_T_erase__SWIG_2(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'map_string_double_t_erase'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'map_string_double_T_erase'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::map< std::string,double >::erase(std::map< std::string,double >::key_type const &)\n"
     "    std::map< std::string,double >::erase(std::map< std::string,double >::iterator)\n"
@@ -23202,7 +23202,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_find(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_find(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::key_type *arg2 = 0 ;
@@ -23213,20 +23213,20 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_find(PyObject *self, PyObject *ar
   std::map< std::string,double >::iterator result;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "map_string_double_t_find", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "map_string_double_T_find", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_find" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_find" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t_find" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T_find" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t_find" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T_find" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -23241,7 +23241,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_lower_bound(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_lower_bound(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::key_type *arg2 = 0 ;
@@ -23252,20 +23252,20 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_lower_bound(PyObject *self, PyObj
   std::map< std::string,double >::iterator result;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "map_string_double_t_lower_bound", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "map_string_double_T_lower_bound", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_lower_bound" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_lower_bound" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t_lower_bound" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T_lower_bound" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t_lower_bound" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T_lower_bound" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -23280,7 +23280,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_upper_bound(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_upper_bound(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::key_type *arg2 = 0 ;
@@ -23291,20 +23291,20 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_upper_bound(PyObject *self, PyObj
   std::map< std::string,double >::iterator result;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "map_string_double_t_upper_bound", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "map_string_double_T_upper_bound", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_upper_bound" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_upper_bound" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t_upper_bound" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T_upper_bound" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t_upper_bound" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T_upper_bound" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -23319,7 +23319,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_delete_map_string_double_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_delete_map_string_double_T(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -23331,7 +23331,7 @@ SWIGINTERN PyObject *_wrap_delete_map_string_double_t(PyObject *self, PyObject *
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, SWIG_POINTER_DISOWN |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_map_string_double_t" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_map_string_double_T" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
@@ -23352,18 +23352,18 @@ fail:
 }
 
 
-SWIGINTERN PyObject *map_string_double_t_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *map_string_double_T_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   PyObject *obj;
   if (!SWIG_Python_UnpackTuple(args, "swigregister", 1, 1, &obj)) return NULL;
   SWIG_TypeNewClientData(SWIGTYPE_p_std__mapT_std__string_double_t, SWIG_NewClientData(obj));
   return SWIG_Py_Void();
 }
 
-SWIGINTERN PyObject *map_string_double_t_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *map_string_double_T_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   return SWIG_Python_InitShadowInstance(args);
 }
 
-SWIGINTERN PyObject *_wrap_new_pvacuum_double_t__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
+SWIGINTERN PyObject *_wrap_new_pvacuum_double_T__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
   PyObject *resultobj = 0;
   std::pair< double,double > *result = 0 ;
   
@@ -23377,7 +23377,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_pvacuum_double_t__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_pvacuum_double_T__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   double arg1 ;
   double arg2 ;
@@ -23391,12 +23391,12 @@ SWIGINTERN PyObject *_wrap_new_pvacuum_double_t__SWIG_1(PyObject *self, Py_ssize
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   ecode1 = SWIG_AsVal_double(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_pvacuum_double_t" "', argument " "1"" of type '" "double""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_pvacuum_double_T" "', argument " "1"" of type '" "double""'");
   } 
   arg1 = static_cast< double >(val1);
   ecode2 = SWIG_AsVal_double(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "new_pvacuum_double_t" "', argument " "2"" of type '" "double""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "new_pvacuum_double_T" "', argument " "2"" of type '" "double""'");
   } 
   arg2 = static_cast< double >(val2);
   result = (std::pair< double,double > *)new std::pair< double,double >(arg1,arg2);
@@ -23407,7 +23407,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_pvacuum_double_t__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_pvacuum_double_T__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::pair< double,double > *arg1 = 0 ;
   int res1 = SWIG_OLDOBJ ;
@@ -23419,10 +23419,10 @@ SWIGINTERN PyObject *_wrap_new_pvacuum_double_t__SWIG_2(PyObject *self, Py_ssize
     std::pair< double,double > *ptr = (std::pair< double,double > *)0;
     res1 = swig::asptr(swig_obj[0], &ptr);
     if (!SWIG_IsOK(res1)) {
-      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_pvacuum_double_t" "', argument " "1"" of type '" "std::pair< double,double > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_pvacuum_double_T" "', argument " "1"" of type '" "std::pair< double,double > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_pvacuum_double_t" "', argument " "1"" of type '" "std::pair< double,double > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_pvacuum_double_T" "', argument " "1"" of type '" "std::pair< double,double > const &""'"); 
     }
     arg1 = ptr;
   }
@@ -23436,23 +23436,23 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_pvacuum_double_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_new_pvacuum_double_T(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "new_pvacuum_double_t", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "new_pvacuum_double_T", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 0) {
-    return _wrap_new_pvacuum_double_t__SWIG_0(self, argc, argv);
+    return _wrap_new_pvacuum_double_T__SWIG_0(self, argc, argv);
   }
   if (argc == 1) {
     int _v = 0;
     int res = swig::asptr(argv[0], (std::pair< double,double >**)(0));
     _v = SWIG_CheckState(res);
     if (_v) {
-      return _wrap_new_pvacuum_double_t__SWIG_2(self, argc, argv);
+      return _wrap_new_pvacuum_double_T__SWIG_2(self, argc, argv);
     }
   }
   if (argc == 2) {
@@ -23467,13 +23467,13 @@ SWIGINTERN PyObject *_wrap_new_pvacuum_double_t(PyObject *self, PyObject *args)
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_new_pvacuum_double_t__SWIG_1(self, argc, argv);
+        return _wrap_new_pvacuum_double_T__SWIG_1(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_pvacuum_double_t'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_pvacuum_double_T'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::pair< double,double >::pair()\n"
     "    std::pair< double,double >::pair(double,double)\n"
@@ -23482,7 +23482,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_pvacuum_double_t_first_set(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_pvacuum_double_T_first_set(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::pair< double,double > *arg1 = (std::pair< double,double > *) 0 ;
   double arg2 ;
@@ -23493,15 +23493,15 @@ SWIGINTERN PyObject *_wrap_pvacuum_double_t_first_set(PyObject *self, PyObject *
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "pvacuum_double_t_first_set", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "pvacuum_double_T_first_set", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__pairT_double_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "pvacuum_double_t_first_set" "', argument " "1"" of type '" "std::pair< double,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "pvacuum_double_T_first_set" "', argument " "1"" of type '" "std::pair< double,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::pair< double,double > * >(argp1);
   ecode2 = SWIG_AsVal_double(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "pvacuum_double_t_first_set" "', argument " "2"" of type '" "double""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "pvacuum_double_T_first_set" "', argument " "2"" of type '" "double""'");
   } 
   arg2 = static_cast< double >(val2);
   if (arg1) (arg1)->first = arg2;
@@ -23512,7 +23512,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_pvacuum_double_t_first_get(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_pvacuum_double_T_first_get(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::pair< double,double > *arg1 = (std::pair< double,double > *) 0 ;
   void *argp1 = 0 ;
@@ -23525,7 +23525,7 @@ SWIGINTERN PyObject *_wrap_pvacuum_double_t_first_get(PyObject *self, PyObject *
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__pairT_double_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "pvacuum_double_t_first_get" "', argument " "1"" of type '" "std::pair< double,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "pvacuum_double_T_first_get" "', argument " "1"" of type '" "std::pair< double,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::pair< double,double > * >(argp1);
   result = (double) ((arg1)->first);
@@ -23536,7 +23536,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_pvacuum_double_t_second_set(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_pvacuum_double_T_second_set(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::pair< double,double > *arg1 = (std::pair< double,double > *) 0 ;
   double arg2 ;
@@ -23547,15 +23547,15 @@ SWIGINTERN PyObject *_wrap_pvacuum_double_t_second_set(PyObject *self, PyObject
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "pvacuum_double_t_second_set", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "pvacuum_double_T_second_set", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__pairT_double_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "pvacuum_double_t_second_set" "', argument " "1"" of type '" "std::pair< double,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "pvacuum_double_T_second_set" "', argument " "1"" of type '" "std::pair< double,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::pair< double,double > * >(argp1);
   ecode2 = SWIG_AsVal_double(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "pvacuum_double_t_second_set" "', argument " "2"" of type '" "double""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "pvacuum_double_T_second_set" "', argument " "2"" of type '" "double""'");
   } 
   arg2 = static_cast< double >(val2);
   if (arg1) (arg1)->second = arg2;
@@ -23566,7 +23566,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_pvacuum_double_t_second_get(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_pvacuum_double_T_second_get(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::pair< double,double > *arg1 = (std::pair< double,double > *) 0 ;
   void *argp1 = 0 ;
@@ -23579,7 +23579,7 @@ SWIGINTERN PyObject *_wrap_pvacuum_double_t_second_get(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__pairT_double_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "pvacuum_double_t_second_get" "', argument " "1"" of type '" "std::pair< double,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "pvacuum_double_T_second_get" "', argument " "1"" of type '" "std::pair< double,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::pair< double,double > * >(argp1);
   result = (double) ((arg1)->second);
@@ -23590,7 +23590,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_delete_pvacuum_double_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_delete_pvacuum_double_T(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::pair< double,double > *arg1 = (std::pair< double,double > *) 0 ;
   void *argp1 = 0 ;
@@ -23602,7 +23602,7 @@ SWIGINTERN PyObject *_wrap_delete_pvacuum_double_t(PyObject *self, PyObject *arg
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__pairT_double_double_t, SWIG_POINTER_DISOWN |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_pvacuum_double_t" "', argument " "1"" of type '" "std::pair< double,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_pvacuum_double_T" "', argument " "1"" of type '" "std::pair< double,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::pair< double,double > * >(argp1);
   {
@@ -23623,18 +23623,18 @@ fail:
 }
 
 
-SWIGINTERN PyObject *pvacuum_double_t_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *pvacuum_double_T_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   PyObject *obj;
   if (!SWIG_Python_UnpackTuple(args, "swigregister", 1, 1, &obj)) return NULL;
   SWIG_TypeNewClientData(SWIGTYPE_p_std__pairT_double_double_t, SWIG_NewClientData(obj));
   return SWIG_Py_Void();
 }
 
-SWIGINTERN PyObject *pvacuum_double_t_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *pvacuum_double_T_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   return SWIG_Python_InitShadowInstance(args);
 }
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_iterator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_iterator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   PyObject **arg2 = (PyObject **) 0 ;
@@ -23649,7 +23649,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_iterator(PyObject *self, PyOb
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_iterator" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_iterator" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = (swig::SwigPyIterator *)std_vector_Sl_std_pair_Sl_double_Sc_double_Sg__Sg__iterator(arg1,arg2);
@@ -23660,7 +23660,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___nonzero__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___nonzero__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -23673,7 +23673,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___nonzero__(PyObject *self, P
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___nonzero__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___nonzero__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = (bool)std_vector_Sl_std_pair_Sl_double_Sc_double_Sg__Sg____nonzero__((std::vector< std::pair< double,double > > const *)arg1);
@@ -23684,7 +23684,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___bool__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___bool__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -23697,7 +23697,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___bool__(PyObject *self, PyOb
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___bool__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___bool__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = (bool)std_vector_Sl_std_pair_Sl_double_Sc_double_Sg__Sg____bool__((std::vector< std::pair< double,double > > const *)arg1);
@@ -23708,7 +23708,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___len__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___len__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -23721,7 +23721,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___len__(PyObject *self, PyObj
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___len__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___len__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = std_vector_Sl_std_pair_Sl_double_Sc_double_Sg__Sg____len__((std::vector< std::pair< double,double > > const *)arg1);
@@ -23732,7 +23732,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___getslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___getslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::difference_type arg2 ;
@@ -23747,20 +23747,20 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___getslice__(PyObject *self,
   std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > *result = 0 ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t___getslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T___getslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___getslice__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___getslice__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_t___getslice__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_T___getslice__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::pair< double,double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_pvacuum_double_t___getslice__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_pvacuum_double_T___getslice__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::pair< double,double > >::difference_type >(val3);
   try {
@@ -23777,7 +23777,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::difference_type arg2 ;
@@ -23793,17 +23793,17 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setslice____SWIG_0(PyObject
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___setslice__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___setslice__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_t___setslice__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_T___setslice__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::pair< double,double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_pvacuum_double_t___setslice__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_pvacuum_double_T___setslice__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::pair< double,double > >::difference_type >(val3);
   try {
@@ -23820,7 +23820,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::difference_type arg2 ;
@@ -23838,27 +23838,27 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setslice____SWIG_1(PyObject
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___setslice__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___setslice__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_t___setslice__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_T___setslice__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::pair< double,double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_pvacuum_double_t___setslice__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_pvacuum_double_T___setslice__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::pair< double,double > >::difference_type >(val3);
   {
     std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > *ptr = (std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > *)0;
     res4 = swig::asptr(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_pvacuum_double_t___setslice__" "', argument " "4"" of type '" "std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_pvacuum_double_T___setslice__" "', argument " "4"" of type '" "std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_t___setslice__" "', argument " "4"" of type '" "std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_T___setslice__" "', argument " "4"" of type '" "std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > const &""'"); 
     }
     arg4 = ptr;
   }
@@ -23878,13 +23878,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___setslice__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t___setslice__", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T___setslice__", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -23901,7 +23901,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setslice__(PyObject *self,
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_pvacuum_double_t___setslice____SWIG_0(self, argc, argv);
+          return _wrap_vector_pvacuum_double_T___setslice____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -23924,7 +23924,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setslice__(PyObject *self,
           int res = swig::asptr(argv[3], (std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > >**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vector_pvacuum_double_t___setslice____SWIG_1(self, argc, argv);
+            return _wrap_vector_pvacuum_double_T___setslice____SWIG_1(self, argc, argv);
           }
         }
       }
@@ -23932,7 +23932,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setslice__(PyObject *self,
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_t___setslice__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_T___setslice__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::pair< double,double > >::__setslice__(std::vector< std::pair< double,double > >::difference_type,std::vector< std::pair< double,double > >::difference_type)\n"
     "    std::vector< std::pair< double,double > >::__setslice__(std::vector< std::pair< double,double > >::difference_type,std::vector< std::pair< double,double > >::difference_type,std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > const &)\n");
@@ -23940,7 +23940,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___delslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___delslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::difference_type arg2 ;
@@ -23954,20 +23954,20 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___delslice__(PyObject *self,
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t___delslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T___delslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___delslice__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___delslice__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_t___delslice__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_T___delslice__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::pair< double,double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_pvacuum_double_t___delslice__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_pvacuum_double_T___delslice__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::pair< double,double > >::difference_type >(val3);
   try {
@@ -23984,7 +23984,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::difference_type arg2 ;
@@ -23997,12 +23997,12 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___delitem____SWIG_0(PyObject
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___delitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___delitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_t___delitem__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_T___delitem__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::pair< double,double > >::difference_type >(val2);
   try {
@@ -24019,7 +24019,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -24031,12 +24031,12 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___getitem____SWIG_0(PyObject
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___getitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___getitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -24054,7 +24054,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -24067,12 +24067,12 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setitem____SWIG_0(PyObject
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___setitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___setitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -24080,10 +24080,10 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setitem____SWIG_0(PyObject
     std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > *ptr = (std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_pvacuum_double_t___setitem__" "', argument " "3"" of type '" "std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_pvacuum_double_T___setitem__" "', argument " "3"" of type '" "std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_t___setitem__" "', argument " "3"" of type '" "std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_T___setitem__" "', argument " "3"" of type '" "std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > const &""'"); 
     }
     arg3 = ptr;
   }
@@ -24103,7 +24103,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -24114,12 +24114,12 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setitem____SWIG_1(PyObject
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___setitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___setitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -24137,7 +24137,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -24148,12 +24148,12 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___delitem____SWIG_1(PyObject
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___delitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___delitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -24171,13 +24171,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___delitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___delitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t___delitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T___delitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -24188,7 +24188,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___delitem__(PyObject *self, P
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_pvacuum_double_t___delitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_pvacuum_double_T___delitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -24202,13 +24202,13 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___delitem__(PyObject *self, P
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_pvacuum_double_t___delitem____SWIG_0(self, argc, argv);
+        return _wrap_vector_pvacuum_double_T___delitem____SWIG_0(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_t___delitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_T___delitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::pair< double,double > >::__delitem__(std::vector< std::pair< double,double > >::difference_type)\n"
     "    std::vector< std::pair< double,double > >::__delitem__(SWIGPY_SLICEOBJECT *)\n");
@@ -24216,7 +24216,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::difference_type arg2 ;
@@ -24230,12 +24230,12 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___getitem____SWIG_1(PyObject
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___getitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___getitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_t___getitem__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_T___getitem__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::pair< double,double > >::difference_type >(val2);
   try {
@@ -24251,13 +24251,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___getitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___getitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t___getitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T___getitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -24268,7 +24268,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___getitem__(PyObject *self, P
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_pvacuum_double_t___getitem____SWIG_0(self, argc, argv);
+        return _wrap_vector_pvacuum_double_T___getitem____SWIG_0(self, argc, argv);
       }
     }
   }
@@ -24282,13 +24282,13 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___getitem__(PyObject *self, P
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_pvacuum_double_t___getitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_pvacuum_double_T___getitem____SWIG_1(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_t___getitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_T___getitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::pair< double,double > >::__getitem__(SWIGPY_SLICEOBJECT *)\n"
     "    std::vector< std::pair< double,double > >::__getitem__(std::vector< std::pair< double,double > >::difference_type) const\n");
@@ -24296,7 +24296,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::difference_type arg2 ;
@@ -24311,22 +24311,22 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setitem____SWIG_2(PyObject
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___setitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___setitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_t___setitem__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_T___setitem__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::pair< double,double > >::difference_type >(val2);
   {
     std::pair< double,double > *ptr = (std::pair< double,double > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_pvacuum_double_t___setitem__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_pvacuum_double_T___setitem__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_t___setitem__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_T___setitem__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -24344,13 +24344,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___setitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t___setitem__", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T___setitem__", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -24361,7 +24361,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setitem__(PyObject *self, P
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_pvacuum_double_t___setitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_pvacuum_double_T___setitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -24377,7 +24377,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setitem__(PyObject *self, P
         int res = swig::asptr(argv[2], (std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vector_pvacuum_double_t___setitem____SWIG_0(self, argc, argv);
+          return _wrap_vector_pvacuum_double_T___setitem____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -24395,14 +24395,14 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setitem__(PyObject *self, P
         int res = swig::asptr(argv[2], (std::pair< double,double >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vector_pvacuum_double_t___setitem____SWIG_2(self, argc, argv);
+          return _wrap_vector_pvacuum_double_T___setitem____SWIG_2(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_t___setitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_T___setitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::pair< double,double > >::__setitem__(SWIGPY_SLICEOBJECT *,std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > const &)\n"
     "    std::vector< std::pair< double,double > >::__setitem__(SWIGPY_SLICEOBJECT *)\n"
@@ -24411,7 +24411,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_pop(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_pop(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -24424,7 +24424,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_pop(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_pop" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_pop" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   try {
@@ -24439,7 +24439,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_append(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_append(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::value_type *arg2 = 0 ;
@@ -24449,20 +24449,20 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_append(PyObject *self, PyObje
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t_append", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T_append", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_append" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_append" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   {
     std::pair< double,double > *ptr = (std::pair< double,double > *)0;
     res2 = swig::asptr(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_pvacuum_double_t_append" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_pvacuum_double_T_append" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_t_append" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_T_append" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -24476,7 +24476,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_t__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
+SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_T__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *result = 0 ;
   
@@ -24490,7 +24490,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_t__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_T__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = 0 ;
   int res1 = SWIG_OLDOBJ ;
@@ -24502,10 +24502,10 @@ SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_t__SWIG_1(PyObject *self, P
     std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > *ptr = (std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > *)0;
     res1 = swig::asptr(swig_obj[0], &ptr);
     if (!SWIG_IsOK(res1)) {
-      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vector_pvacuum_double_t" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vector_pvacuum_double_T" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_pvacuum_double_t" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_pvacuum_double_T" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const &""'"); 
     }
     arg1 = ptr;
   }
@@ -24519,7 +24519,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_empty(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_empty(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -24532,7 +24532,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_empty(PyObject *self, PyObjec
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_empty" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_empty" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = (bool)((std::vector< std::pair< double,double > > const *)arg1)->empty();
@@ -24543,7 +24543,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_size(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_size(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -24556,7 +24556,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_size(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_size" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_size" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = ((std::vector< std::pair< double,double > > const *)arg1)->size();
@@ -24567,7 +24567,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_swap(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_swap(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > > *arg2 = 0 ;
@@ -24578,18 +24578,18 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_swap(PyObject *self, PyObject
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t_swap", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T_swap", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_swap" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_swap" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], &argp2, SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t,  0 );
   if (!SWIG_IsOK(res2)) {
-    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_pvacuum_double_t_swap" "', argument " "2"" of type '" "std::vector< std::pair< double,double > > &""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_pvacuum_double_T_swap" "', argument " "2"" of type '" "std::vector< std::pair< double,double > > &""'"); 
   }
   if (!argp2) {
-    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_t_swap" "', argument " "2"" of type '" "std::vector< std::pair< double,double > > &""'"); 
+    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_T_swap" "', argument " "2"" of type '" "std::vector< std::pair< double,double > > &""'"); 
   }
   arg2 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp2);
   (arg1)->swap(*arg2);
@@ -24600,7 +24600,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_begin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_begin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -24613,7 +24613,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_begin(PyObject *self, PyObjec
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_begin" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_begin" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = (arg1)->begin();
@@ -24625,7 +24625,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_end(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_end(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -24638,7 +24638,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_end(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_end" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_end" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = (arg1)->end();
@@ -24650,7 +24650,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_rbegin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_rbegin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -24663,7 +24663,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_rbegin(PyObject *self, PyObje
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_rbegin" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_rbegin" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = (arg1)->rbegin();
@@ -24675,7 +24675,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_rend(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_rend(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -24688,7 +24688,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_rend(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_rend" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_rend" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = (arg1)->rend();
@@ -24700,7 +24700,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_clear(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_clear(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -24712,7 +24712,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_clear(PyObject *self, PyObjec
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_clear" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_clear" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   (arg1)->clear();
@@ -24723,7 +24723,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_get_allocator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_get_allocator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -24736,7 +24736,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_get_allocator(PyObject *self,
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_get_allocator" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_get_allocator" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = ((std::vector< std::pair< double,double > > const *)arg1)->get_allocator();
@@ -24747,7 +24747,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_t__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_T__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > >::size_type arg1 ;
   size_t val1 ;
@@ -24758,7 +24758,7 @@ SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_t__SWIG_2(PyObject *self, P
   if ((nobjs < 1) || (nobjs > 1)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_pvacuum_double_t" "', argument " "1"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_pvacuum_double_T" "', argument " "1"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
   } 
   arg1 = static_cast< std::vector< std::pair< double,double > >::size_type >(val1);
   result = (std::vector< std::pair< double,double > > *)new std::vector< std::pair< double,double > >(arg1);
@@ -24769,7 +24769,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_pop_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_pop_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -24781,7 +24781,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_pop_back(PyObject *self, PyOb
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_pop_back" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_pop_back" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   (arg1)->pop_back();
@@ -24792,7 +24792,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::size_type arg2 ;
@@ -24805,12 +24805,12 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_resize__SWIG_0(PyObject *self
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_resize" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_resize" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_t_resize" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_T_resize" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::pair< double,double > >::size_type >(val2);
   (arg1)->resize(arg2);
@@ -24821,7 +24821,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::iterator arg2 ;
@@ -24835,18 +24835,18 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_erase__SWIG_0(PyObject *self,
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_erase" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_erase" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t_erase" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T_erase" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t_erase" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T_erase" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
     }
   }
   result = std_vector_Sl_std_pair_Sl_double_Sc_double_Sg__Sg__erase__SWIG_0(arg1,SWIG_STD_MOVE(arg2));
@@ -24858,7 +24858,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::iterator arg2 ;
@@ -24875,29 +24875,29 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_erase__SWIG_1(PyObject *self,
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_erase" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_erase" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t_erase" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T_erase" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t_erase" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T_erase" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
     }
   }
   res3 = SWIG_ConvertPtr(swig_obj[2], SWIG_as_voidptrptr(&iter3), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res3) || !iter3) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t_erase" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T_erase" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *>(iter3);
     if (iter_t) {
       arg3 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t_erase" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T_erase" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
     }
   }
   result = std_vector_Sl_std_pair_Sl_double_Sc_double_Sg__Sg__erase__SWIG_1(arg1,SWIG_STD_MOVE(arg2),SWIG_STD_MOVE(arg3));
@@ -24909,13 +24909,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_erase(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_erase(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t_erase", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T_erase", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -24926,7 +24926,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_erase(PyObject *self, PyObjec
       int res = SWIG_ConvertPtr(argv[1], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
       _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *>(iter) != 0));
       if (_v) {
-        return _wrap_vector_pvacuum_double_t_erase__SWIG_0(self, argc, argv);
+        return _wrap_vector_pvacuum_double_T_erase__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -24943,14 +24943,14 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_erase(PyObject *self, PyObjec
         int res = SWIG_ConvertPtr(argv[2], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
         _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *>(iter) != 0));
         if (_v) {
-          return _wrap_vector_pvacuum_double_t_erase__SWIG_1(self, argc, argv);
+          return _wrap_vector_pvacuum_double_T_erase__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_t_erase'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_T_erase'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::pair< double,double > >::erase(std::vector< std::pair< double,double > >::iterator)\n"
     "    std::vector< std::pair< double,double > >::erase(std::vector< std::pair< double,double > >::iterator,std::vector< std::pair< double,double > >::iterator)\n");
@@ -24958,7 +24958,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_t__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_T__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > >::size_type arg1 ;
   std::vector< std::pair< double,double > >::value_type *arg2 = 0 ;
@@ -24971,17 +24971,17 @@ SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_t__SWIG_3(PyObject *self, P
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_pvacuum_double_t" "', argument " "1"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_pvacuum_double_T" "', argument " "1"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
   } 
   arg1 = static_cast< std::vector< std::pair< double,double > >::size_type >(val1);
   {
     std::pair< double,double > *ptr = (std::pair< double,double > *)0;
     res2 = swig::asptr(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "new_vector_pvacuum_double_t" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "new_vector_pvacuum_double_T" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_pvacuum_double_t" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_pvacuum_double_T" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -24995,16 +24995,16 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_T(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vector_pvacuum_double_t", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vector_pvacuum_double_T", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 0) {
-    return _wrap_new_vector_pvacuum_double_t__SWIG_0(self, argc, argv);
+    return _wrap_new_vector_pvacuum_double_T__SWIG_0(self, argc, argv);
   }
   if (argc == 1) {
     int _v = 0;
@@ -25013,7 +25013,7 @@ SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_t(PyObject *self, PyObject
       _v = SWIG_CheckState(res);
     }
     if (_v) {
-      return _wrap_new_vector_pvacuum_double_t__SWIG_2(self, argc, argv);
+      return _wrap_new_vector_pvacuum_double_T__SWIG_2(self, argc, argv);
     }
   }
   if (argc == 1) {
@@ -25021,7 +25021,7 @@ SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_t(PyObject *self, PyObject
     int res = swig::asptr(argv[0], (std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > >**)(0));
     _v = SWIG_CheckState(res);
     if (_v) {
-      return _wrap_new_vector_pvacuum_double_t__SWIG_1(self, argc, argv);
+      return _wrap_new_vector_pvacuum_double_T__SWIG_1(self, argc, argv);
     }
   }
   if (argc == 2) {
@@ -25034,13 +25034,13 @@ SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_t(PyObject *self, PyObject
       int res = swig::asptr(argv[1], (std::pair< double,double >**)(0));
       _v = SWIG_CheckState(res);
       if (_v) {
-        return _wrap_new_vector_pvacuum_double_t__SWIG_3(self, argc, argv);
+        return _wrap_new_vector_pvacuum_double_T__SWIG_3(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vector_pvacuum_double_t'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vector_pvacuum_double_T'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::pair< double,double > >::vector()\n"
     "    std::vector< std::pair< double,double > >::vector(std::vector< std::pair< double,double > > const &)\n"
@@ -25050,7 +25050,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_push_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_push_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::value_type *arg2 = 0 ;
@@ -25060,20 +25060,20 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_push_back(PyObject *self, PyO
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t_push_back", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T_push_back", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_push_back" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_push_back" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   {
     std::pair< double,double > *ptr = (std::pair< double,double > *)0;
     res2 = swig::asptr(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_pvacuum_double_t_push_back" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_pvacuum_double_T_push_back" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_t_push_back" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_T_push_back" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -25087,7 +25087,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_front(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_front(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -25100,7 +25100,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_front(PyObject *self, PyObjec
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_front" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_front" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = (std::vector< std::pair< double,double > >::value_type *) &((std::vector< std::pair< double,double > > const *)arg1)->front();
@@ -25112,7 +25112,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -25125,7 +25125,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_back(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_back" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_back" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = (std::vector< std::pair< double,double > >::value_type *) &((std::vector< std::pair< double,double > > const *)arg1)->back();
@@ -25137,7 +25137,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_assign(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_assign(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::size_type arg2 ;
@@ -25150,25 +25150,25 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_assign(PyObject *self, PyObje
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t_assign", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T_assign", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_assign" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_assign" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_t_assign" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_T_assign" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::pair< double,double > >::size_type >(val2);
   {
     std::pair< double,double > *ptr = (std::pair< double,double > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_pvacuum_double_t_assign" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_pvacuum_double_T_assign" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_t_assign" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_T_assign" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -25182,7 +25182,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::size_type arg2 ;
@@ -25197,22 +25197,22 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_resize__SWIG_1(PyObject *self
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_resize" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_resize" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_t_resize" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_T_resize" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::pair< double,double > >::size_type >(val2);
   {
     std::pair< double,double > *ptr = (std::pair< double,double > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_pvacuum_double_t_resize" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_pvacuum_double_T_resize" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_t_resize" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_T_resize" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -25226,13 +25226,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_resize(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_resize(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t_resize", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T_resize", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -25244,7 +25244,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_resize(PyObject *self, PyObje
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_pvacuum_double_t_resize__SWIG_0(self, argc, argv);
+        return _wrap_vector_pvacuum_double_T_resize__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -25261,14 +25261,14 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_resize(PyObject *self, PyObje
         int res = swig::asptr(argv[2], (std::pair< double,double >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vector_pvacuum_double_t_resize__SWIG_1(self, argc, argv);
+          return _wrap_vector_pvacuum_double_T_resize__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_t_resize'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_T_resize'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::pair< double,double > >::resize(std::vector< std::pair< double,double > >::size_type)\n"
     "    std::vector< std::pair< double,double > >::resize(std::vector< std::pair< double,double > >::size_type,std::vector< std::pair< double,double > >::value_type const &)\n");
@@ -25276,7 +25276,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::iterator arg2 ;
@@ -25292,28 +25292,28 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_insert__SWIG_0(PyObject *self
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_insert" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_insert" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t_insert" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T_insert" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t_insert" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T_insert" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
     }
   }
   {
     std::pair< double,double > *ptr = (std::pair< double,double > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_pvacuum_double_t_insert" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_pvacuum_double_T_insert" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_t_insert" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_T_insert" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -25328,7 +25328,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::iterator arg2 ;
@@ -25346,33 +25346,33 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_insert__SWIG_1(PyObject *self
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_insert" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_insert" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t_insert" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T_insert" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t_insert" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T_insert" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_size_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_pvacuum_double_t_insert" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_pvacuum_double_T_insert" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
   } 
   arg3 = static_cast< std::vector< std::pair< double,double > >::size_type >(val3);
   {
     std::pair< double,double > *ptr = (std::pair< double,double > *)0;
     res4 = swig::asptr(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_pvacuum_double_t_insert" "', argument " "4"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_pvacuum_double_T_insert" "', argument " "4"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_t_insert" "', argument " "4"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_T_insert" "', argument " "4"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     arg4 = ptr;
   }
@@ -25386,13 +25386,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_insert(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_insert(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t_insert", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T_insert", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -25406,7 +25406,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_insert(PyObject *self, PyObje
         int res = swig::asptr(argv[2], (std::pair< double,double >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vector_pvacuum_double_t_insert__SWIG_0(self, argc, argv);
+          return _wrap_vector_pvacuum_double_T_insert__SWIG_0(self, argc, argv);
         }
       }
     }
@@ -25428,7 +25428,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_insert(PyObject *self, PyObje
           int res = swig::asptr(argv[3], (std::pair< double,double >**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vector_pvacuum_double_t_insert__SWIG_1(self, argc, argv);
+            return _wrap_vector_pvacuum_double_T_insert__SWIG_1(self, argc, argv);
           }
         }
       }
@@ -25436,7 +25436,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_insert(PyObject *self, PyObje
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_t_insert'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_T_insert'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::pair< double,double > >::insert(std::vector< std::pair< double,double > >::iterator,std::vector< std::pair< double,double > >::value_type const &)\n"
     "    std::vector< std::pair< double,double > >::insert(std::vector< std::pair< double,double > >::iterator,std::vector< std::pair< double,double > >::size_type,std::vector< std::pair< double,double > >::value_type const &)\n");
@@ -25444,7 +25444,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_reserve(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_reserve(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::size_type arg2 ;
@@ -25455,15 +25455,15 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_reserve(PyObject *self, PyObj
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t_reserve", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T_reserve", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_reserve" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_reserve" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_t_reserve" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_T_reserve" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::pair< double,double > >::size_type >(val2);
   (arg1)->reserve(arg2);
@@ -25474,7 +25474,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_capacity(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_capacity(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -25487,7 +25487,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_capacity(PyObject *self, PyOb
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_capacity" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_capacity" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = ((std::vector< std::pair< double,double > > const *)arg1)->capacity();
@@ -25498,7 +25498,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_delete_vector_pvacuum_double_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_delete_vector_pvacuum_double_T(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -25510,7 +25510,7 @@ SWIGINTERN PyObject *_wrap_delete_vector_pvacuum_double_t(PyObject *self, PyObje
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, SWIG_POINTER_DISOWN |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vector_pvacuum_double_t" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vector_pvacuum_double_T" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   {
@@ -25531,14 +25531,14 @@ fail:
 }
 
 
-SWIGINTERN PyObject *vector_pvacuum_double_t_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vector_pvacuum_double_T_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   PyObject *obj;
   if (!SWIG_Python_UnpackTuple(args, "swigregister", 1, 1, &obj)) return NULL;
   SWIG_TypeNewClientData(SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, SWIG_NewClientData(obj));
   return SWIG_Py_Void();
 }
 
-SWIGINTERN PyObject *vector_pvacuum_double_t_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vector_pvacuum_double_T_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   return SWIG_Python_InitShadowInstance(args);
 }
 
@@ -71801,558 +71801,558 @@ static PyMethodDef SwigMethods[] = {
 		"SwigPyIterator___sub__(SwigPyIterator self, SwigPyIterator x) -> ptrdiff_t\n"
 		""},
 	 { "SwigPyIterator_swigregister", SwigPyIterator_swigregister, METH_O, NULL},
-	 { "vdouble1d_t_iterator", _wrap_vdouble1d_t_iterator, METH_O, "vdouble1d_t_iterator(vdouble1d_t self) -> SwigPyIterator"},
-	 { "vdouble1d_t___nonzero__", _wrap_vdouble1d_t___nonzero__, METH_O, "vdouble1d_t___nonzero__(vdouble1d_t self) -> bool"},
-	 { "vdouble1d_t___bool__", _wrap_vdouble1d_t___bool__, METH_O, "vdouble1d_t___bool__(vdouble1d_t self) -> bool"},
-	 { "vdouble1d_t___len__", _wrap_vdouble1d_t___len__, METH_O, "vdouble1d_t___len__(vdouble1d_t self) -> std::vector< double >::size_type"},
-	 { "vdouble1d_t___getslice__", _wrap_vdouble1d_t___getslice__, METH_VARARGS, "vdouble1d_t___getslice__(vdouble1d_t self, std::vector< double >::difference_type i, std::vector< double >::difference_type j) -> vdouble1d_t"},
-	 { "vdouble1d_t___setslice__", _wrap_vdouble1d_t___setslice__, METH_VARARGS, "\n"
-		"vdouble1d_t___setslice__(vdouble1d_t self, std::vector< double >::difference_type i, std::vector< double >::difference_type j)\n"
-		"vdouble1d_t___setslice__(vdouble1d_t self, std::vector< double >::difference_type i, std::vector< double >::difference_type j, vdouble1d_t v)\n"
+	 { "vdouble1d_T_iterator", _wrap_vdouble1d_T_iterator, METH_O, "vdouble1d_T_iterator(vdouble1d_T self) -> SwigPyIterator"},
+	 { "vdouble1d_T___nonzero__", _wrap_vdouble1d_T___nonzero__, METH_O, "vdouble1d_T___nonzero__(vdouble1d_T self) -> bool"},
+	 { "vdouble1d_T___bool__", _wrap_vdouble1d_T___bool__, METH_O, "vdouble1d_T___bool__(vdouble1d_T self) -> bool"},
+	 { "vdouble1d_T___len__", _wrap_vdouble1d_T___len__, METH_O, "vdouble1d_T___len__(vdouble1d_T self) -> std::vector< double >::size_type"},
+	 { "vdouble1d_T___getslice__", _wrap_vdouble1d_T___getslice__, METH_VARARGS, "vdouble1d_T___getslice__(vdouble1d_T self, std::vector< double >::difference_type i, std::vector< double >::difference_type j) -> vdouble1d_T"},
+	 { "vdouble1d_T___setslice__", _wrap_vdouble1d_T___setslice__, METH_VARARGS, "\n"
+		"vdouble1d_T___setslice__(vdouble1d_T self, std::vector< double >::difference_type i, std::vector< double >::difference_type j)\n"
+		"vdouble1d_T___setslice__(vdouble1d_T self, std::vector< double >::difference_type i, std::vector< double >::difference_type j, vdouble1d_T v)\n"
 		""},
-	 { "vdouble1d_t___delslice__", _wrap_vdouble1d_t___delslice__, METH_VARARGS, "vdouble1d_t___delslice__(vdouble1d_t self, std::vector< double >::difference_type i, std::vector< double >::difference_type j)"},
-	 { "vdouble1d_t___delitem__", _wrap_vdouble1d_t___delitem__, METH_VARARGS, "\n"
-		"vdouble1d_t___delitem__(vdouble1d_t self, std::vector< double >::difference_type i)\n"
-		"vdouble1d_t___delitem__(vdouble1d_t self, SWIGPY_SLICEOBJECT * slice)\n"
+	 { "vdouble1d_T___delslice__", _wrap_vdouble1d_T___delslice__, METH_VARARGS, "vdouble1d_T___delslice__(vdouble1d_T self, std::vector< double >::difference_type i, std::vector< double >::difference_type j)"},
+	 { "vdouble1d_T___delitem__", _wrap_vdouble1d_T___delitem__, METH_VARARGS, "\n"
+		"vdouble1d_T___delitem__(vdouble1d_T self, std::vector< double >::difference_type i)\n"
+		"vdouble1d_T___delitem__(vdouble1d_T self, SWIGPY_SLICEOBJECT * slice)\n"
 		""},
-	 { "vdouble1d_t___getitem__", _wrap_vdouble1d_t___getitem__, METH_VARARGS, "\n"
-		"vdouble1d_t___getitem__(vdouble1d_t self, SWIGPY_SLICEOBJECT * slice) -> vdouble1d_t\n"
-		"vdouble1d_t___getitem__(vdouble1d_t self, std::vector< double >::difference_type i) -> std::vector< double >::value_type const &\n"
+	 { "vdouble1d_T___getitem__", _wrap_vdouble1d_T___getitem__, METH_VARARGS, "\n"
+		"vdouble1d_T___getitem__(vdouble1d_T self, SWIGPY_SLICEOBJECT * slice) -> vdouble1d_T\n"
+		"vdouble1d_T___getitem__(vdouble1d_T self, std::vector< double >::difference_type i) -> std::vector< double >::value_type const &\n"
 		""},
-	 { "vdouble1d_t___setitem__", _wrap_vdouble1d_t___setitem__, METH_VARARGS, "\n"
-		"vdouble1d_t___setitem__(vdouble1d_t self, SWIGPY_SLICEOBJECT * slice, vdouble1d_t v)\n"
-		"vdouble1d_t___setitem__(vdouble1d_t self, SWIGPY_SLICEOBJECT * slice)\n"
-		"vdouble1d_t___setitem__(vdouble1d_t self, std::vector< double >::difference_type i, std::vector< double >::value_type const & x)\n"
+	 { "vdouble1d_T___setitem__", _wrap_vdouble1d_T___setitem__, METH_VARARGS, "\n"
+		"vdouble1d_T___setitem__(vdouble1d_T self, SWIGPY_SLICEOBJECT * slice, vdouble1d_T v)\n"
+		"vdouble1d_T___setitem__(vdouble1d_T self, SWIGPY_SLICEOBJECT * slice)\n"
+		"vdouble1d_T___setitem__(vdouble1d_T self, std::vector< double >::difference_type i, std::vector< double >::value_type const & x)\n"
 		""},
-	 { "vdouble1d_t_pop", _wrap_vdouble1d_t_pop, METH_O, "vdouble1d_t_pop(vdouble1d_t self) -> std::vector< double >::value_type"},
-	 { "vdouble1d_t_append", _wrap_vdouble1d_t_append, METH_VARARGS, "vdouble1d_t_append(vdouble1d_t self, std::vector< double >::value_type const & x)"},
-	 { "vdouble1d_t_empty", _wrap_vdouble1d_t_empty, METH_O, "vdouble1d_t_empty(vdouble1d_t self) -> bool"},
-	 { "vdouble1d_t_size", _wrap_vdouble1d_t_size, METH_O, "vdouble1d_t_size(vdouble1d_t self) -> std::vector< double >::size_type"},
-	 { "vdouble1d_t_swap", _wrap_vdouble1d_t_swap, METH_VARARGS, "vdouble1d_t_swap(vdouble1d_t self, vdouble1d_t v)"},
-	 { "vdouble1d_t_begin", _wrap_vdouble1d_t_begin, METH_O, "vdouble1d_t_begin(vdouble1d_t self) -> std::vector< double >::iterator"},
-	 { "vdouble1d_t_end", _wrap_vdouble1d_t_end, METH_O, "vdouble1d_t_end(vdouble1d_t self) -> std::vector< double >::iterator"},
-	 { "vdouble1d_t_rbegin", _wrap_vdouble1d_t_rbegin, METH_O, "vdouble1d_t_rbegin(vdouble1d_t self) -> std::vector< double >::reverse_iterator"},
-	 { "vdouble1d_t_rend", _wrap_vdouble1d_t_rend, METH_O, "vdouble1d_t_rend(vdouble1d_t self) -> std::vector< double >::reverse_iterator"},
-	 { "vdouble1d_t_clear", _wrap_vdouble1d_t_clear, METH_O, "vdouble1d_t_clear(vdouble1d_t self)"},
-	 { "vdouble1d_t_get_allocator", _wrap_vdouble1d_t_get_allocator, METH_O, "vdouble1d_t_get_allocator(vdouble1d_t self) -> std::vector< double >::allocator_type"},
-	 { "vdouble1d_t_pop_back", _wrap_vdouble1d_t_pop_back, METH_O, "vdouble1d_t_pop_back(vdouble1d_t self)"},
-	 { "vdouble1d_t_erase", _wrap_vdouble1d_t_erase, METH_VARARGS, "\n"
-		"vdouble1d_t_erase(vdouble1d_t self, std::vector< double >::iterator pos) -> std::vector< double >::iterator\n"
-		"vdouble1d_t_erase(vdouble1d_t self, std::vector< double >::iterator first, std::vector< double >::iterator last) -> std::vector< double >::iterator\n"
+	 { "vdouble1d_T_pop", _wrap_vdouble1d_T_pop, METH_O, "vdouble1d_T_pop(vdouble1d_T self) -> std::vector< double >::value_type"},
+	 { "vdouble1d_T_append", _wrap_vdouble1d_T_append, METH_VARARGS, "vdouble1d_T_append(vdouble1d_T self, std::vector< double >::value_type const & x)"},
+	 { "vdouble1d_T_empty", _wrap_vdouble1d_T_empty, METH_O, "vdouble1d_T_empty(vdouble1d_T self) -> bool"},
+	 { "vdouble1d_T_size", _wrap_vdouble1d_T_size, METH_O, "vdouble1d_T_size(vdouble1d_T self) -> std::vector< double >::size_type"},
+	 { "vdouble1d_T_swap", _wrap_vdouble1d_T_swap, METH_VARARGS, "vdouble1d_T_swap(vdouble1d_T self, vdouble1d_T v)"},
+	 { "vdouble1d_T_begin", _wrap_vdouble1d_T_begin, METH_O, "vdouble1d_T_begin(vdouble1d_T self) -> std::vector< double >::iterator"},
+	 { "vdouble1d_T_end", _wrap_vdouble1d_T_end, METH_O, "vdouble1d_T_end(vdouble1d_T self) -> std::vector< double >::iterator"},
+	 { "vdouble1d_T_rbegin", _wrap_vdouble1d_T_rbegin, METH_O, "vdouble1d_T_rbegin(vdouble1d_T self) -> std::vector< double >::reverse_iterator"},
+	 { "vdouble1d_T_rend", _wrap_vdouble1d_T_rend, METH_O, "vdouble1d_T_rend(vdouble1d_T self) -> std::vector< double >::reverse_iterator"},
+	 { "vdouble1d_T_clear", _wrap_vdouble1d_T_clear, METH_O, "vdouble1d_T_clear(vdouble1d_T self)"},
+	 { "vdouble1d_T_get_allocator", _wrap_vdouble1d_T_get_allocator, METH_O, "vdouble1d_T_get_allocator(vdouble1d_T self) -> std::vector< double >::allocator_type"},
+	 { "vdouble1d_T_pop_back", _wrap_vdouble1d_T_pop_back, METH_O, "vdouble1d_T_pop_back(vdouble1d_T self)"},
+	 { "vdouble1d_T_erase", _wrap_vdouble1d_T_erase, METH_VARARGS, "\n"
+		"vdouble1d_T_erase(vdouble1d_T self, std::vector< double >::iterator pos) -> std::vector< double >::iterator\n"
+		"vdouble1d_T_erase(vdouble1d_T self, std::vector< double >::iterator first, std::vector< double >::iterator last) -> std::vector< double >::iterator\n"
 		""},
-	 { "new_vdouble1d_t", _wrap_new_vdouble1d_t, METH_VARARGS, "\n"
-		"vdouble1d_t()\n"
-		"vdouble1d_t(vdouble1d_t other)\n"
-		"vdouble1d_t(std::vector< double >::size_type size)\n"
-		"new_vdouble1d_t(std::vector< double >::size_type size, std::vector< double >::value_type const & value) -> vdouble1d_t\n"
+	 { "new_vdouble1d_T", _wrap_new_vdouble1d_T, METH_VARARGS, "\n"
+		"vdouble1d_T()\n"
+		"vdouble1d_T(vdouble1d_T other)\n"
+		"vdouble1d_T(std::vector< double >::size_type size)\n"
+		"new_vdouble1d_T(std::vector< double >::size_type size, std::vector< double >::value_type const & value) -> vdouble1d_T\n"
 		""},
-	 { "vdouble1d_t_push_back", _wrap_vdouble1d_t_push_back, METH_VARARGS, "vdouble1d_t_push_back(vdouble1d_t self, std::vector< double >::value_type const & x)"},
-	 { "vdouble1d_t_front", _wrap_vdouble1d_t_front, METH_O, "vdouble1d_t_front(vdouble1d_t self) -> std::vector< double >::value_type const &"},
-	 { "vdouble1d_t_back", _wrap_vdouble1d_t_back, METH_O, "vdouble1d_t_back(vdouble1d_t self) -> std::vector< double >::value_type const &"},
-	 { "vdouble1d_t_assign", _wrap_vdouble1d_t_assign, METH_VARARGS, "vdouble1d_t_assign(vdouble1d_t self, std::vector< double >::size_type n, std::vector< double >::value_type const & x)"},
-	 { "vdouble1d_t_resize", _wrap_vdouble1d_t_resize, METH_VARARGS, "\n"
-		"vdouble1d_t_resize(vdouble1d_t self, std::vector< double >::size_type new_size)\n"
-		"vdouble1d_t_resize(vdouble1d_t self, std::vector< double >::size_type new_size, std::vector< double >::value_type const & x)\n"
+	 { "vdouble1d_T_push_back", _wrap_vdouble1d_T_push_back, METH_VARARGS, "vdouble1d_T_push_back(vdouble1d_T self, std::vector< double >::value_type const & x)"},
+	 { "vdouble1d_T_front", _wrap_vdouble1d_T_front, METH_O, "vdouble1d_T_front(vdouble1d_T self) -> std::vector< double >::value_type const &"},
+	 { "vdouble1d_T_back", _wrap_vdouble1d_T_back, METH_O, "vdouble1d_T_back(vdouble1d_T self) -> std::vector< double >::value_type const &"},
+	 { "vdouble1d_T_assign", _wrap_vdouble1d_T_assign, METH_VARARGS, "vdouble1d_T_assign(vdouble1d_T self, std::vector< double >::size_type n, std::vector< double >::value_type const & x)"},
+	 { "vdouble1d_T_resize", _wrap_vdouble1d_T_resize, METH_VARARGS, "\n"
+		"vdouble1d_T_resize(vdouble1d_T self, std::vector< double >::size_type new_size)\n"
+		"vdouble1d_T_resize(vdouble1d_T self, std::vector< double >::size_type new_size, std::vector< double >::value_type const & x)\n"
 		""},
-	 { "vdouble1d_t_insert", _wrap_vdouble1d_t_insert, METH_VARARGS, "\n"
-		"vdouble1d_t_insert(vdouble1d_t self, std::vector< double >::iterator pos, std::vector< double >::value_type const & x) -> std::vector< double >::iterator\n"
-		"vdouble1d_t_insert(vdouble1d_t self, std::vector< double >::iterator pos, std::vector< double >::size_type n, std::vector< double >::value_type const & x)\n"
+	 { "vdouble1d_T_insert", _wrap_vdouble1d_T_insert, METH_VARARGS, "\n"
+		"vdouble1d_T_insert(vdouble1d_T self, std::vector< double >::iterator pos, std::vector< double >::value_type const & x) -> std::vector< double >::iterator\n"
+		"vdouble1d_T_insert(vdouble1d_T self, std::vector< double >::iterator pos, std::vector< double >::size_type n, std::vector< double >::value_type const & x)\n"
 		""},
-	 { "vdouble1d_t_reserve", _wrap_vdouble1d_t_reserve, METH_VARARGS, "vdouble1d_t_reserve(vdouble1d_t self, std::vector< double >::size_type n)"},
-	 { "vdouble1d_t_capacity", _wrap_vdouble1d_t_capacity, METH_O, "vdouble1d_t_capacity(vdouble1d_t self) -> std::vector< double >::size_type"},
-	 { "delete_vdouble1d_t", _wrap_delete_vdouble1d_t, METH_O, "delete_vdouble1d_t(vdouble1d_t self)"},
-	 { "vdouble1d_t_swigregister", vdouble1d_t_swigregister, METH_O, NULL},
-	 { "vdouble1d_t_swiginit", vdouble1d_t_swiginit, METH_VARARGS, NULL},
-	 { "vdouble2d_t_iterator", _wrap_vdouble2d_t_iterator, METH_O, "vdouble2d_t_iterator(vdouble2d_t self) -> SwigPyIterator"},
-	 { "vdouble2d_t___nonzero__", _wrap_vdouble2d_t___nonzero__, METH_O, "vdouble2d_t___nonzero__(vdouble2d_t self) -> bool"},
-	 { "vdouble2d_t___bool__", _wrap_vdouble2d_t___bool__, METH_O, "vdouble2d_t___bool__(vdouble2d_t self) -> bool"},
-	 { "vdouble2d_t___len__", _wrap_vdouble2d_t___len__, METH_O, "vdouble2d_t___len__(vdouble2d_t self) -> std::vector< std::vector< double > >::size_type"},
-	 { "vdouble2d_t___getslice__", _wrap_vdouble2d_t___getslice__, METH_VARARGS, "vdouble2d_t___getslice__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j) -> vdouble2d_t"},
-	 { "vdouble2d_t___setslice__", _wrap_vdouble2d_t___setslice__, METH_VARARGS, "\n"
-		"vdouble2d_t___setslice__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j)\n"
-		"vdouble2d_t___setslice__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j, vdouble2d_t v)\n"
+	 { "vdouble1d_T_reserve", _wrap_vdouble1d_T_reserve, METH_VARARGS, "vdouble1d_T_reserve(vdouble1d_T self, std::vector< double >::size_type n)"},
+	 { "vdouble1d_T_capacity", _wrap_vdouble1d_T_capacity, METH_O, "vdouble1d_T_capacity(vdouble1d_T self) -> std::vector< double >::size_type"},
+	 { "delete_vdouble1d_T", _wrap_delete_vdouble1d_T, METH_O, "delete_vdouble1d_T(vdouble1d_T self)"},
+	 { "vdouble1d_T_swigregister", vdouble1d_T_swigregister, METH_O, NULL},
+	 { "vdouble1d_T_swiginit", vdouble1d_T_swiginit, METH_VARARGS, NULL},
+	 { "vdouble2d_T_iterator", _wrap_vdouble2d_T_iterator, METH_O, "vdouble2d_T_iterator(vdouble2d_T self) -> SwigPyIterator"},
+	 { "vdouble2d_T___nonzero__", _wrap_vdouble2d_T___nonzero__, METH_O, "vdouble2d_T___nonzero__(vdouble2d_T self) -> bool"},
+	 { "vdouble2d_T___bool__", _wrap_vdouble2d_T___bool__, METH_O, "vdouble2d_T___bool__(vdouble2d_T self) -> bool"},
+	 { "vdouble2d_T___len__", _wrap_vdouble2d_T___len__, METH_O, "vdouble2d_T___len__(vdouble2d_T self) -> std::vector< std::vector< double > >::size_type"},
+	 { "vdouble2d_T___getslice__", _wrap_vdouble2d_T___getslice__, METH_VARARGS, "vdouble2d_T___getslice__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j) -> vdouble2d_T"},
+	 { "vdouble2d_T___setslice__", _wrap_vdouble2d_T___setslice__, METH_VARARGS, "\n"
+		"vdouble2d_T___setslice__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j)\n"
+		"vdouble2d_T___setslice__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j, vdouble2d_T v)\n"
 		""},
-	 { "vdouble2d_t___delslice__", _wrap_vdouble2d_t___delslice__, METH_VARARGS, "vdouble2d_t___delslice__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j)"},
-	 { "vdouble2d_t___delitem__", _wrap_vdouble2d_t___delitem__, METH_VARARGS, "\n"
-		"vdouble2d_t___delitem__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i)\n"
-		"vdouble2d_t___delitem__(vdouble2d_t self, SWIGPY_SLICEOBJECT * slice)\n"
+	 { "vdouble2d_T___delslice__", _wrap_vdouble2d_T___delslice__, METH_VARARGS, "vdouble2d_T___delslice__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j)"},
+	 { "vdouble2d_T___delitem__", _wrap_vdouble2d_T___delitem__, METH_VARARGS, "\n"
+		"vdouble2d_T___delitem__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i)\n"
+		"vdouble2d_T___delitem__(vdouble2d_T self, SWIGPY_SLICEOBJECT * slice)\n"
 		""},
-	 { "vdouble2d_t___getitem__", _wrap_vdouble2d_t___getitem__, METH_VARARGS, "\n"
-		"vdouble2d_t___getitem__(vdouble2d_t self, SWIGPY_SLICEOBJECT * slice) -> vdouble2d_t\n"
-		"vdouble2d_t___getitem__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i) -> vdouble1d_t\n"
+	 { "vdouble2d_T___getitem__", _wrap_vdouble2d_T___getitem__, METH_VARARGS, "\n"
+		"vdouble2d_T___getitem__(vdouble2d_T self, SWIGPY_SLICEOBJECT * slice) -> vdouble2d_T\n"
+		"vdouble2d_T___getitem__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i) -> vdouble1d_T\n"
 		""},
-	 { "vdouble2d_t___setitem__", _wrap_vdouble2d_t___setitem__, METH_VARARGS, "\n"
-		"vdouble2d_t___setitem__(vdouble2d_t self, SWIGPY_SLICEOBJECT * slice, vdouble2d_t v)\n"
-		"vdouble2d_t___setitem__(vdouble2d_t self, SWIGPY_SLICEOBJECT * slice)\n"
-		"vdouble2d_t___setitem__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i, vdouble1d_t x)\n"
+	 { "vdouble2d_T___setitem__", _wrap_vdouble2d_T___setitem__, METH_VARARGS, "\n"
+		"vdouble2d_T___setitem__(vdouble2d_T self, SWIGPY_SLICEOBJECT * slice, vdouble2d_T v)\n"
+		"vdouble2d_T___setitem__(vdouble2d_T self, SWIGPY_SLICEOBJECT * slice)\n"
+		"vdouble2d_T___setitem__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i, vdouble1d_T x)\n"
 		""},
-	 { "vdouble2d_t_pop", _wrap_vdouble2d_t_pop, METH_O, "vdouble2d_t_pop(vdouble2d_t self) -> vdouble1d_t"},
-	 { "vdouble2d_t_append", _wrap_vdouble2d_t_append, METH_VARARGS, "vdouble2d_t_append(vdouble2d_t self, vdouble1d_t x)"},
-	 { "vdouble2d_t_empty", _wrap_vdouble2d_t_empty, METH_O, "vdouble2d_t_empty(vdouble2d_t self) -> bool"},
-	 { "vdouble2d_t_size", _wrap_vdouble2d_t_size, METH_O, "vdouble2d_t_size(vdouble2d_t self) -> std::vector< std::vector< double > >::size_type"},
-	 { "vdouble2d_t_swap", _wrap_vdouble2d_t_swap, METH_VARARGS, "vdouble2d_t_swap(vdouble2d_t self, vdouble2d_t v)"},
-	 { "vdouble2d_t_begin", _wrap_vdouble2d_t_begin, METH_O, "vdouble2d_t_begin(vdouble2d_t self) -> std::vector< std::vector< double > >::iterator"},
-	 { "vdouble2d_t_end", _wrap_vdouble2d_t_end, METH_O, "vdouble2d_t_end(vdouble2d_t self) -> std::vector< std::vector< double > >::iterator"},
-	 { "vdouble2d_t_rbegin", _wrap_vdouble2d_t_rbegin, METH_O, "vdouble2d_t_rbegin(vdouble2d_t self) -> std::vector< std::vector< double > >::reverse_iterator"},
-	 { "vdouble2d_t_rend", _wrap_vdouble2d_t_rend, METH_O, "vdouble2d_t_rend(vdouble2d_t self) -> std::vector< std::vector< double > >::reverse_iterator"},
-	 { "vdouble2d_t_clear", _wrap_vdouble2d_t_clear, METH_O, "vdouble2d_t_clear(vdouble2d_t self)"},
-	 { "vdouble2d_t_get_allocator", _wrap_vdouble2d_t_get_allocator, METH_O, "vdouble2d_t_get_allocator(vdouble2d_t self) -> std::vector< std::vector< double > >::allocator_type"},
-	 { "vdouble2d_t_pop_back", _wrap_vdouble2d_t_pop_back, METH_O, "vdouble2d_t_pop_back(vdouble2d_t self)"},
-	 { "vdouble2d_t_erase", _wrap_vdouble2d_t_erase, METH_VARARGS, "\n"
-		"vdouble2d_t_erase(vdouble2d_t self, std::vector< std::vector< double > >::iterator pos) -> std::vector< std::vector< double > >::iterator\n"
-		"vdouble2d_t_erase(vdouble2d_t self, std::vector< std::vector< double > >::iterator first, std::vector< std::vector< double > >::iterator last) -> std::vector< std::vector< double > >::iterator\n"
+	 { "vdouble2d_T_pop", _wrap_vdouble2d_T_pop, METH_O, "vdouble2d_T_pop(vdouble2d_T self) -> vdouble1d_T"},
+	 { "vdouble2d_T_append", _wrap_vdouble2d_T_append, METH_VARARGS, "vdouble2d_T_append(vdouble2d_T self, vdouble1d_T x)"},
+	 { "vdouble2d_T_empty", _wrap_vdouble2d_T_empty, METH_O, "vdouble2d_T_empty(vdouble2d_T self) -> bool"},
+	 { "vdouble2d_T_size", _wrap_vdouble2d_T_size, METH_O, "vdouble2d_T_size(vdouble2d_T self) -> std::vector< std::vector< double > >::size_type"},
+	 { "vdouble2d_T_swap", _wrap_vdouble2d_T_swap, METH_VARARGS, "vdouble2d_T_swap(vdouble2d_T self, vdouble2d_T v)"},
+	 { "vdouble2d_T_begin", _wrap_vdouble2d_T_begin, METH_O, "vdouble2d_T_begin(vdouble2d_T self) -> std::vector< std::vector< double > >::iterator"},
+	 { "vdouble2d_T_end", _wrap_vdouble2d_T_end, METH_O, "vdouble2d_T_end(vdouble2d_T self) -> std::vector< std::vector< double > >::iterator"},
+	 { "vdouble2d_T_rbegin", _wrap_vdouble2d_T_rbegin, METH_O, "vdouble2d_T_rbegin(vdouble2d_T self) -> std::vector< std::vector< double > >::reverse_iterator"},
+	 { "vdouble2d_T_rend", _wrap_vdouble2d_T_rend, METH_O, "vdouble2d_T_rend(vdouble2d_T self) -> std::vector< std::vector< double > >::reverse_iterator"},
+	 { "vdouble2d_T_clear", _wrap_vdouble2d_T_clear, METH_O, "vdouble2d_T_clear(vdouble2d_T self)"},
+	 { "vdouble2d_T_get_allocator", _wrap_vdouble2d_T_get_allocator, METH_O, "vdouble2d_T_get_allocator(vdouble2d_T self) -> std::vector< std::vector< double > >::allocator_type"},
+	 { "vdouble2d_T_pop_back", _wrap_vdouble2d_T_pop_back, METH_O, "vdouble2d_T_pop_back(vdouble2d_T self)"},
+	 { "vdouble2d_T_erase", _wrap_vdouble2d_T_erase, METH_VARARGS, "\n"
+		"vdouble2d_T_erase(vdouble2d_T self, std::vector< std::vector< double > >::iterator pos) -> std::vector< std::vector< double > >::iterator\n"
+		"vdouble2d_T_erase(vdouble2d_T self, std::vector< std::vector< double > >::iterator first, std::vector< std::vector< double > >::iterator last) -> std::vector< std::vector< double > >::iterator\n"
 		""},
-	 { "new_vdouble2d_t", _wrap_new_vdouble2d_t, METH_VARARGS, "\n"
-		"vdouble2d_t()\n"
-		"vdouble2d_t(vdouble2d_t other)\n"
-		"vdouble2d_t(std::vector< std::vector< double > >::size_type size)\n"
-		"new_vdouble2d_t(std::vector< std::vector< double > >::size_type size, vdouble1d_t value) -> vdouble2d_t\n"
+	 { "new_vdouble2d_T", _wrap_new_vdouble2d_T, METH_VARARGS, "\n"
+		"vdouble2d_T()\n"
+		"vdouble2d_T(vdouble2d_T other)\n"
+		"vdouble2d_T(std::vector< std::vector< double > >::size_type size)\n"
+		"new_vdouble2d_T(std::vector< std::vector< double > >::size_type size, vdouble1d_T value) -> vdouble2d_T\n"
 		""},
-	 { "vdouble2d_t_push_back", _wrap_vdouble2d_t_push_back, METH_VARARGS, "vdouble2d_t_push_back(vdouble2d_t self, vdouble1d_t x)"},
-	 { "vdouble2d_t_front", _wrap_vdouble2d_t_front, METH_O, "vdouble2d_t_front(vdouble2d_t self) -> vdouble1d_t"},
-	 { "vdouble2d_t_back", _wrap_vdouble2d_t_back, METH_O, "vdouble2d_t_back(vdouble2d_t self) -> vdouble1d_t"},
-	 { "vdouble2d_t_assign", _wrap_vdouble2d_t_assign, METH_VARARGS, "vdouble2d_t_assign(vdouble2d_t self, std::vector< std::vector< double > >::size_type n, vdouble1d_t x)"},
-	 { "vdouble2d_t_resize", _wrap_vdouble2d_t_resize, METH_VARARGS, "\n"
-		"vdouble2d_t_resize(vdouble2d_t self, std::vector< std::vector< double > >::size_type new_size)\n"
-		"vdouble2d_t_resize(vdouble2d_t self, std::vector< std::vector< double > >::size_type new_size, vdouble1d_t x)\n"
+	 { "vdouble2d_T_push_back", _wrap_vdouble2d_T_push_back, METH_VARARGS, "vdouble2d_T_push_back(vdouble2d_T self, vdouble1d_T x)"},
+	 { "vdouble2d_T_front", _wrap_vdouble2d_T_front, METH_O, "vdouble2d_T_front(vdouble2d_T self) -> vdouble1d_T"},
+	 { "vdouble2d_T_back", _wrap_vdouble2d_T_back, METH_O, "vdouble2d_T_back(vdouble2d_T self) -> vdouble1d_T"},
+	 { "vdouble2d_T_assign", _wrap_vdouble2d_T_assign, METH_VARARGS, "vdouble2d_T_assign(vdouble2d_T self, std::vector< std::vector< double > >::size_type n, vdouble1d_T x)"},
+	 { "vdouble2d_T_resize", _wrap_vdouble2d_T_resize, METH_VARARGS, "\n"
+		"vdouble2d_T_resize(vdouble2d_T self, std::vector< std::vector< double > >::size_type new_size)\n"
+		"vdouble2d_T_resize(vdouble2d_T self, std::vector< std::vector< double > >::size_type new_size, vdouble1d_T x)\n"
 		""},
-	 { "vdouble2d_t_insert", _wrap_vdouble2d_t_insert, METH_VARARGS, "\n"
-		"vdouble2d_t_insert(vdouble2d_t self, std::vector< std::vector< double > >::iterator pos, vdouble1d_t x) -> std::vector< std::vector< double > >::iterator\n"
-		"vdouble2d_t_insert(vdouble2d_t self, std::vector< std::vector< double > >::iterator pos, std::vector< std::vector< double > >::size_type n, vdouble1d_t x)\n"
+	 { "vdouble2d_T_insert", _wrap_vdouble2d_T_insert, METH_VARARGS, "\n"
+		"vdouble2d_T_insert(vdouble2d_T self, std::vector< std::vector< double > >::iterator pos, vdouble1d_T x) -> std::vector< std::vector< double > >::iterator\n"
+		"vdouble2d_T_insert(vdouble2d_T self, std::vector< std::vector< double > >::iterator pos, std::vector< std::vector< double > >::size_type n, vdouble1d_T x)\n"
 		""},
-	 { "vdouble2d_t_reserve", _wrap_vdouble2d_t_reserve, METH_VARARGS, "vdouble2d_t_reserve(vdouble2d_t self, std::vector< std::vector< double > >::size_type n)"},
-	 { "vdouble2d_t_capacity", _wrap_vdouble2d_t_capacity, METH_O, "vdouble2d_t_capacity(vdouble2d_t self) -> std::vector< std::vector< double > >::size_type"},
-	 { "delete_vdouble2d_t", _wrap_delete_vdouble2d_t, METH_O, "delete_vdouble2d_t(vdouble2d_t self)"},
-	 { "vdouble2d_t_swigregister", vdouble2d_t_swigregister, METH_O, NULL},
-	 { "vdouble2d_t_swiginit", vdouble2d_t_swiginit, METH_VARARGS, NULL},
-	 { "vector_integer_t_iterator", _wrap_vector_integer_t_iterator, METH_O, "vector_integer_t_iterator(vector_integer_t self) -> SwigPyIterator"},
-	 { "vector_integer_t___nonzero__", _wrap_vector_integer_t___nonzero__, METH_O, "vector_integer_t___nonzero__(vector_integer_t self) -> bool"},
-	 { "vector_integer_t___bool__", _wrap_vector_integer_t___bool__, METH_O, "vector_integer_t___bool__(vector_integer_t self) -> bool"},
-	 { "vector_integer_t___len__", _wrap_vector_integer_t___len__, METH_O, "vector_integer_t___len__(vector_integer_t self) -> std::vector< int >::size_type"},
-	 { "vector_integer_t___getslice__", _wrap_vector_integer_t___getslice__, METH_VARARGS, "vector_integer_t___getslice__(vector_integer_t self, std::vector< int >::difference_type i, std::vector< int >::difference_type j) -> vector_integer_t"},
-	 { "vector_integer_t___setslice__", _wrap_vector_integer_t___setslice__, METH_VARARGS, "\n"
-		"vector_integer_t___setslice__(vector_integer_t self, std::vector< int >::difference_type i, std::vector< int >::difference_type j)\n"
-		"vector_integer_t___setslice__(vector_integer_t self, std::vector< int >::difference_type i, std::vector< int >::difference_type j, vector_integer_t v)\n"
+	 { "vdouble2d_T_reserve", _wrap_vdouble2d_T_reserve, METH_VARARGS, "vdouble2d_T_reserve(vdouble2d_T self, std::vector< std::vector< double > >::size_type n)"},
+	 { "vdouble2d_T_capacity", _wrap_vdouble2d_T_capacity, METH_O, "vdouble2d_T_capacity(vdouble2d_T self) -> std::vector< std::vector< double > >::size_type"},
+	 { "delete_vdouble2d_T", _wrap_delete_vdouble2d_T, METH_O, "delete_vdouble2d_T(vdouble2d_T self)"},
+	 { "vdouble2d_T_swigregister", vdouble2d_T_swigregister, METH_O, NULL},
+	 { "vdouble2d_T_swiginit", vdouble2d_T_swiginit, METH_VARARGS, NULL},
+	 { "vector_integer_T_iterator", _wrap_vector_integer_T_iterator, METH_O, "vector_integer_T_iterator(vector_integer_T self) -> SwigPyIterator"},
+	 { "vector_integer_T___nonzero__", _wrap_vector_integer_T___nonzero__, METH_O, "vector_integer_T___nonzero__(vector_integer_T self) -> bool"},
+	 { "vector_integer_T___bool__", _wrap_vector_integer_T___bool__, METH_O, "vector_integer_T___bool__(vector_integer_T self) -> bool"},
+	 { "vector_integer_T___len__", _wrap_vector_integer_T___len__, METH_O, "vector_integer_T___len__(vector_integer_T self) -> std::vector< int >::size_type"},
+	 { "vector_integer_T___getslice__", _wrap_vector_integer_T___getslice__, METH_VARARGS, "vector_integer_T___getslice__(vector_integer_T self, std::vector< int >::difference_type i, std::vector< int >::difference_type j) -> vector_integer_T"},
+	 { "vector_integer_T___setslice__", _wrap_vector_integer_T___setslice__, METH_VARARGS, "\n"
+		"vector_integer_T___setslice__(vector_integer_T self, std::vector< int >::difference_type i, std::vector< int >::difference_type j)\n"
+		"vector_integer_T___setslice__(vector_integer_T self, std::vector< int >::difference_type i, std::vector< int >::difference_type j, vector_integer_T v)\n"
 		""},
-	 { "vector_integer_t___delslice__", _wrap_vector_integer_t___delslice__, METH_VARARGS, "vector_integer_t___delslice__(vector_integer_t self, std::vector< int >::difference_type i, std::vector< int >::difference_type j)"},
-	 { "vector_integer_t___delitem__", _wrap_vector_integer_t___delitem__, METH_VARARGS, "\n"
-		"vector_integer_t___delitem__(vector_integer_t self, std::vector< int >::difference_type i)\n"
-		"vector_integer_t___delitem__(vector_integer_t self, SWIGPY_SLICEOBJECT * slice)\n"
+	 { "vector_integer_T___delslice__", _wrap_vector_integer_T___delslice__, METH_VARARGS, "vector_integer_T___delslice__(vector_integer_T self, std::vector< int >::difference_type i, std::vector< int >::difference_type j)"},
+	 { "vector_integer_T___delitem__", _wrap_vector_integer_T___delitem__, METH_VARARGS, "\n"
+		"vector_integer_T___delitem__(vector_integer_T self, std::vector< int >::difference_type i)\n"
+		"vector_integer_T___delitem__(vector_integer_T self, SWIGPY_SLICEOBJECT * slice)\n"
 		""},
-	 { "vector_integer_t___getitem__", _wrap_vector_integer_t___getitem__, METH_VARARGS, "\n"
-		"vector_integer_t___getitem__(vector_integer_t self, SWIGPY_SLICEOBJECT * slice) -> vector_integer_t\n"
-		"vector_integer_t___getitem__(vector_integer_t self, std::vector< int >::difference_type i) -> std::vector< int >::value_type const &\n"
+	 { "vector_integer_T___getitem__", _wrap_vector_integer_T___getitem__, METH_VARARGS, "\n"
+		"vector_integer_T___getitem__(vector_integer_T self, SWIGPY_SLICEOBJECT * slice) -> vector_integer_T\n"
+		"vector_integer_T___getitem__(vector_integer_T self, std::vector< int >::difference_type i) -> std::vector< int >::value_type const &\n"
 		""},
-	 { "vector_integer_t___setitem__", _wrap_vector_integer_t___setitem__, METH_VARARGS, "\n"
-		"vector_integer_t___setitem__(vector_integer_t self, SWIGPY_SLICEOBJECT * slice, vector_integer_t v)\n"
-		"vector_integer_t___setitem__(vector_integer_t self, SWIGPY_SLICEOBJECT * slice)\n"
-		"vector_integer_t___setitem__(vector_integer_t self, std::vector< int >::difference_type i, std::vector< int >::value_type const & x)\n"
+	 { "vector_integer_T___setitem__", _wrap_vector_integer_T___setitem__, METH_VARARGS, "\n"
+		"vector_integer_T___setitem__(vector_integer_T self, SWIGPY_SLICEOBJECT * slice, vector_integer_T v)\n"
+		"vector_integer_T___setitem__(vector_integer_T self, SWIGPY_SLICEOBJECT * slice)\n"
+		"vector_integer_T___setitem__(vector_integer_T self, std::vector< int >::difference_type i, std::vector< int >::value_type const & x)\n"
 		""},
-	 { "vector_integer_t_pop", _wrap_vector_integer_t_pop, METH_O, "vector_integer_t_pop(vector_integer_t self) -> std::vector< int >::value_type"},
-	 { "vector_integer_t_append", _wrap_vector_integer_t_append, METH_VARARGS, "vector_integer_t_append(vector_integer_t self, std::vector< int >::value_type const & x)"},
-	 { "vector_integer_t_empty", _wrap_vector_integer_t_empty, METH_O, "vector_integer_t_empty(vector_integer_t self) -> bool"},
-	 { "vector_integer_t_size", _wrap_vector_integer_t_size, METH_O, "vector_integer_t_size(vector_integer_t self) -> std::vector< int >::size_type"},
-	 { "vector_integer_t_swap", _wrap_vector_integer_t_swap, METH_VARARGS, "vector_integer_t_swap(vector_integer_t self, vector_integer_t v)"},
-	 { "vector_integer_t_begin", _wrap_vector_integer_t_begin, METH_O, "vector_integer_t_begin(vector_integer_t self) -> std::vector< int >::iterator"},
-	 { "vector_integer_t_end", _wrap_vector_integer_t_end, METH_O, "vector_integer_t_end(vector_integer_t self) -> std::vector< int >::iterator"},
-	 { "vector_integer_t_rbegin", _wrap_vector_integer_t_rbegin, METH_O, "vector_integer_t_rbegin(vector_integer_t self) -> std::vector< int >::reverse_iterator"},
-	 { "vector_integer_t_rend", _wrap_vector_integer_t_rend, METH_O, "vector_integer_t_rend(vector_integer_t self) -> std::vector< int >::reverse_iterator"},
-	 { "vector_integer_t_clear", _wrap_vector_integer_t_clear, METH_O, "vector_integer_t_clear(vector_integer_t self)"},
-	 { "vector_integer_t_get_allocator", _wrap_vector_integer_t_get_allocator, METH_O, "vector_integer_t_get_allocator(vector_integer_t self) -> std::vector< int >::allocator_type"},
-	 { "vector_integer_t_pop_back", _wrap_vector_integer_t_pop_back, METH_O, "vector_integer_t_pop_back(vector_integer_t self)"},
-	 { "vector_integer_t_erase", _wrap_vector_integer_t_erase, METH_VARARGS, "\n"
-		"vector_integer_t_erase(vector_integer_t self, std::vector< int >::iterator pos) -> std::vector< int >::iterator\n"
-		"vector_integer_t_erase(vector_integer_t self, std::vector< int >::iterator first, std::vector< int >::iterator last) -> std::vector< int >::iterator\n"
+	 { "vector_integer_T_pop", _wrap_vector_integer_T_pop, METH_O, "vector_integer_T_pop(vector_integer_T self) -> std::vector< int >::value_type"},
+	 { "vector_integer_T_append", _wrap_vector_integer_T_append, METH_VARARGS, "vector_integer_T_append(vector_integer_T self, std::vector< int >::value_type const & x)"},
+	 { "vector_integer_T_empty", _wrap_vector_integer_T_empty, METH_O, "vector_integer_T_empty(vector_integer_T self) -> bool"},
+	 { "vector_integer_T_size", _wrap_vector_integer_T_size, METH_O, "vector_integer_T_size(vector_integer_T self) -> std::vector< int >::size_type"},
+	 { "vector_integer_T_swap", _wrap_vector_integer_T_swap, METH_VARARGS, "vector_integer_T_swap(vector_integer_T self, vector_integer_T v)"},
+	 { "vector_integer_T_begin", _wrap_vector_integer_T_begin, METH_O, "vector_integer_T_begin(vector_integer_T self) -> std::vector< int >::iterator"},
+	 { "vector_integer_T_end", _wrap_vector_integer_T_end, METH_O, "vector_integer_T_end(vector_integer_T self) -> std::vector< int >::iterator"},
+	 { "vector_integer_T_rbegin", _wrap_vector_integer_T_rbegin, METH_O, "vector_integer_T_rbegin(vector_integer_T self) -> std::vector< int >::reverse_iterator"},
+	 { "vector_integer_T_rend", _wrap_vector_integer_T_rend, METH_O, "vector_integer_T_rend(vector_integer_T self) -> std::vector< int >::reverse_iterator"},
+	 { "vector_integer_T_clear", _wrap_vector_integer_T_clear, METH_O, "vector_integer_T_clear(vector_integer_T self)"},
+	 { "vector_integer_T_get_allocator", _wrap_vector_integer_T_get_allocator, METH_O, "vector_integer_T_get_allocator(vector_integer_T self) -> std::vector< int >::allocator_type"},
+	 { "vector_integer_T_pop_back", _wrap_vector_integer_T_pop_back, METH_O, "vector_integer_T_pop_back(vector_integer_T self)"},
+	 { "vector_integer_T_erase", _wrap_vector_integer_T_erase, METH_VARARGS, "\n"
+		"vector_integer_T_erase(vector_integer_T self, std::vector< int >::iterator pos) -> std::vector< int >::iterator\n"
+		"vector_integer_T_erase(vector_integer_T self, std::vector< int >::iterator first, std::vector< int >::iterator last) -> std::vector< int >::iterator\n"
 		""},
-	 { "new_vector_integer_t", _wrap_new_vector_integer_t, METH_VARARGS, "\n"
-		"vector_integer_t()\n"
-		"vector_integer_t(vector_integer_t other)\n"
-		"vector_integer_t(std::vector< int >::size_type size)\n"
-		"new_vector_integer_t(std::vector< int >::size_type size, std::vector< int >::value_type const & value) -> vector_integer_t\n"
+	 { "new_vector_integer_T", _wrap_new_vector_integer_T, METH_VARARGS, "\n"
+		"vector_integer_T()\n"
+		"vector_integer_T(vector_integer_T other)\n"
+		"vector_integer_T(std::vector< int >::size_type size)\n"
+		"new_vector_integer_T(std::vector< int >::size_type size, std::vector< int >::value_type const & value) -> vector_integer_T\n"
 		""},
-	 { "vector_integer_t_push_back", _wrap_vector_integer_t_push_back, METH_VARARGS, "vector_integer_t_push_back(vector_integer_t self, std::vector< int >::value_type const & x)"},
-	 { "vector_integer_t_front", _wrap_vector_integer_t_front, METH_O, "vector_integer_t_front(vector_integer_t self) -> std::vector< int >::value_type const &"},
-	 { "vector_integer_t_back", _wrap_vector_integer_t_back, METH_O, "vector_integer_t_back(vector_integer_t self) -> std::vector< int >::value_type const &"},
-	 { "vector_integer_t_assign", _wrap_vector_integer_t_assign, METH_VARARGS, "vector_integer_t_assign(vector_integer_t self, std::vector< int >::size_type n, std::vector< int >::value_type const & x)"},
-	 { "vector_integer_t_resize", _wrap_vector_integer_t_resize, METH_VARARGS, "\n"
-		"vector_integer_t_resize(vector_integer_t self, std::vector< int >::size_type new_size)\n"
-		"vector_integer_t_resize(vector_integer_t self, std::vector< int >::size_type new_size, std::vector< int >::value_type const & x)\n"
+	 { "vector_integer_T_push_back", _wrap_vector_integer_T_push_back, METH_VARARGS, "vector_integer_T_push_back(vector_integer_T self, std::vector< int >::value_type const & x)"},
+	 { "vector_integer_T_front", _wrap_vector_integer_T_front, METH_O, "vector_integer_T_front(vector_integer_T self) -> std::vector< int >::value_type const &"},
+	 { "vector_integer_T_back", _wrap_vector_integer_T_back, METH_O, "vector_integer_T_back(vector_integer_T self) -> std::vector< int >::value_type const &"},
+	 { "vector_integer_T_assign", _wrap_vector_integer_T_assign, METH_VARARGS, "vector_integer_T_assign(vector_integer_T self, std::vector< int >::size_type n, std::vector< int >::value_type const & x)"},
+	 { "vector_integer_T_resize", _wrap_vector_integer_T_resize, METH_VARARGS, "\n"
+		"vector_integer_T_resize(vector_integer_T self, std::vector< int >::size_type new_size)\n"
+		"vector_integer_T_resize(vector_integer_T self, std::vector< int >::size_type new_size, std::vector< int >::value_type const & x)\n"
 		""},
-	 { "vector_integer_t_insert", _wrap_vector_integer_t_insert, METH_VARARGS, "\n"
-		"vector_integer_t_insert(vector_integer_t self, std::vector< int >::iterator pos, std::vector< int >::value_type const & x) -> std::vector< int >::iterator\n"
-		"vector_integer_t_insert(vector_integer_t self, std::vector< int >::iterator pos, std::vector< int >::size_type n, std::vector< int >::value_type const & x)\n"
+	 { "vector_integer_T_insert", _wrap_vector_integer_T_insert, METH_VARARGS, "\n"
+		"vector_integer_T_insert(vector_integer_T self, std::vector< int >::iterator pos, std::vector< int >::value_type const & x) -> std::vector< int >::iterator\n"
+		"vector_integer_T_insert(vector_integer_T self, std::vector< int >::iterator pos, std::vector< int >::size_type n, std::vector< int >::value_type const & x)\n"
 		""},
-	 { "vector_integer_t_reserve", _wrap_vector_integer_t_reserve, METH_VARARGS, "vector_integer_t_reserve(vector_integer_t self, std::vector< int >::size_type n)"},
-	 { "vector_integer_t_capacity", _wrap_vector_integer_t_capacity, METH_O, "vector_integer_t_capacity(vector_integer_t self) -> std::vector< int >::size_type"},
-	 { "delete_vector_integer_t", _wrap_delete_vector_integer_t, METH_O, "delete_vector_integer_t(vector_integer_t self)"},
-	 { "vector_integer_t_swigregister", vector_integer_t_swigregister, METH_O, NULL},
-	 { "vector_integer_t_swiginit", vector_integer_t_swiginit, METH_VARARGS, NULL},
-	 { "vinteger2d_t_iterator", _wrap_vinteger2d_t_iterator, METH_O, "vinteger2d_t_iterator(vinteger2d_t self) -> SwigPyIterator"},
-	 { "vinteger2d_t___nonzero__", _wrap_vinteger2d_t___nonzero__, METH_O, "vinteger2d_t___nonzero__(vinteger2d_t self) -> bool"},
-	 { "vinteger2d_t___bool__", _wrap_vinteger2d_t___bool__, METH_O, "vinteger2d_t___bool__(vinteger2d_t self) -> bool"},
-	 { "vinteger2d_t___len__", _wrap_vinteger2d_t___len__, METH_O, "vinteger2d_t___len__(vinteger2d_t self) -> std::vector< std::vector< int > >::size_type"},
-	 { "vinteger2d_t___getslice__", _wrap_vinteger2d_t___getslice__, METH_VARARGS, "vinteger2d_t___getslice__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j) -> vinteger2d_t"},
-	 { "vinteger2d_t___setslice__", _wrap_vinteger2d_t___setslice__, METH_VARARGS, "\n"
-		"vinteger2d_t___setslice__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j)\n"
-		"vinteger2d_t___setslice__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j, vinteger2d_t v)\n"
+	 { "vector_integer_T_reserve", _wrap_vector_integer_T_reserve, METH_VARARGS, "vector_integer_T_reserve(vector_integer_T self, std::vector< int >::size_type n)"},
+	 { "vector_integer_T_capacity", _wrap_vector_integer_T_capacity, METH_O, "vector_integer_T_capacity(vector_integer_T self) -> std::vector< int >::size_type"},
+	 { "delete_vector_integer_T", _wrap_delete_vector_integer_T, METH_O, "delete_vector_integer_T(vector_integer_T self)"},
+	 { "vector_integer_T_swigregister", vector_integer_T_swigregister, METH_O, NULL},
+	 { "vector_integer_T_swiginit", vector_integer_T_swiginit, METH_VARARGS, NULL},
+	 { "vinteger2d_T_iterator", _wrap_vinteger2d_T_iterator, METH_O, "vinteger2d_T_iterator(vinteger2d_T self) -> SwigPyIterator"},
+	 { "vinteger2d_T___nonzero__", _wrap_vinteger2d_T___nonzero__, METH_O, "vinteger2d_T___nonzero__(vinteger2d_T self) -> bool"},
+	 { "vinteger2d_T___bool__", _wrap_vinteger2d_T___bool__, METH_O, "vinteger2d_T___bool__(vinteger2d_T self) -> bool"},
+	 { "vinteger2d_T___len__", _wrap_vinteger2d_T___len__, METH_O, "vinteger2d_T___len__(vinteger2d_T self) -> std::vector< std::vector< int > >::size_type"},
+	 { "vinteger2d_T___getslice__", _wrap_vinteger2d_T___getslice__, METH_VARARGS, "vinteger2d_T___getslice__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j) -> vinteger2d_T"},
+	 { "vinteger2d_T___setslice__", _wrap_vinteger2d_T___setslice__, METH_VARARGS, "\n"
+		"vinteger2d_T___setslice__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j)\n"
+		"vinteger2d_T___setslice__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j, vinteger2d_T v)\n"
 		""},
-	 { "vinteger2d_t___delslice__", _wrap_vinteger2d_t___delslice__, METH_VARARGS, "vinteger2d_t___delslice__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j)"},
-	 { "vinteger2d_t___delitem__", _wrap_vinteger2d_t___delitem__, METH_VARARGS, "\n"
-		"vinteger2d_t___delitem__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i)\n"
-		"vinteger2d_t___delitem__(vinteger2d_t self, SWIGPY_SLICEOBJECT * slice)\n"
+	 { "vinteger2d_T___delslice__", _wrap_vinteger2d_T___delslice__, METH_VARARGS, "vinteger2d_T___delslice__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j)"},
+	 { "vinteger2d_T___delitem__", _wrap_vinteger2d_T___delitem__, METH_VARARGS, "\n"
+		"vinteger2d_T___delitem__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i)\n"
+		"vinteger2d_T___delitem__(vinteger2d_T self, SWIGPY_SLICEOBJECT * slice)\n"
 		""},
-	 { "vinteger2d_t___getitem__", _wrap_vinteger2d_t___getitem__, METH_VARARGS, "\n"
-		"vinteger2d_t___getitem__(vinteger2d_t self, SWIGPY_SLICEOBJECT * slice) -> vinteger2d_t\n"
-		"vinteger2d_t___getitem__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i) -> vector_integer_t\n"
+	 { "vinteger2d_T___getitem__", _wrap_vinteger2d_T___getitem__, METH_VARARGS, "\n"
+		"vinteger2d_T___getitem__(vinteger2d_T self, SWIGPY_SLICEOBJECT * slice) -> vinteger2d_T\n"
+		"vinteger2d_T___getitem__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i) -> vector_integer_T\n"
 		""},
-	 { "vinteger2d_t___setitem__", _wrap_vinteger2d_t___setitem__, METH_VARARGS, "\n"
-		"vinteger2d_t___setitem__(vinteger2d_t self, SWIGPY_SLICEOBJECT * slice, vinteger2d_t v)\n"
-		"vinteger2d_t___setitem__(vinteger2d_t self, SWIGPY_SLICEOBJECT * slice)\n"
-		"vinteger2d_t___setitem__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i, vector_integer_t x)\n"
+	 { "vinteger2d_T___setitem__", _wrap_vinteger2d_T___setitem__, METH_VARARGS, "\n"
+		"vinteger2d_T___setitem__(vinteger2d_T self, SWIGPY_SLICEOBJECT * slice, vinteger2d_T v)\n"
+		"vinteger2d_T___setitem__(vinteger2d_T self, SWIGPY_SLICEOBJECT * slice)\n"
+		"vinteger2d_T___setitem__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i, vector_integer_T x)\n"
 		""},
-	 { "vinteger2d_t_pop", _wrap_vinteger2d_t_pop, METH_O, "vinteger2d_t_pop(vinteger2d_t self) -> vector_integer_t"},
-	 { "vinteger2d_t_append", _wrap_vinteger2d_t_append, METH_VARARGS, "vinteger2d_t_append(vinteger2d_t self, vector_integer_t x)"},
-	 { "vinteger2d_t_empty", _wrap_vinteger2d_t_empty, METH_O, "vinteger2d_t_empty(vinteger2d_t self) -> bool"},
-	 { "vinteger2d_t_size", _wrap_vinteger2d_t_size, METH_O, "vinteger2d_t_size(vinteger2d_t self) -> std::vector< std::vector< int > >::size_type"},
-	 { "vinteger2d_t_swap", _wrap_vinteger2d_t_swap, METH_VARARGS, "vinteger2d_t_swap(vinteger2d_t self, vinteger2d_t v)"},
-	 { "vinteger2d_t_begin", _wrap_vinteger2d_t_begin, METH_O, "vinteger2d_t_begin(vinteger2d_t self) -> std::vector< std::vector< int > >::iterator"},
-	 { "vinteger2d_t_end", _wrap_vinteger2d_t_end, METH_O, "vinteger2d_t_end(vinteger2d_t self) -> std::vector< std::vector< int > >::iterator"},
-	 { "vinteger2d_t_rbegin", _wrap_vinteger2d_t_rbegin, METH_O, "vinteger2d_t_rbegin(vinteger2d_t self) -> std::vector< std::vector< int > >::reverse_iterator"},
-	 { "vinteger2d_t_rend", _wrap_vinteger2d_t_rend, METH_O, "vinteger2d_t_rend(vinteger2d_t self) -> std::vector< std::vector< int > >::reverse_iterator"},
-	 { "vinteger2d_t_clear", _wrap_vinteger2d_t_clear, METH_O, "vinteger2d_t_clear(vinteger2d_t self)"},
-	 { "vinteger2d_t_get_allocator", _wrap_vinteger2d_t_get_allocator, METH_O, "vinteger2d_t_get_allocator(vinteger2d_t self) -> std::vector< std::vector< int > >::allocator_type"},
-	 { "vinteger2d_t_pop_back", _wrap_vinteger2d_t_pop_back, METH_O, "vinteger2d_t_pop_back(vinteger2d_t self)"},
-	 { "vinteger2d_t_erase", _wrap_vinteger2d_t_erase, METH_VARARGS, "\n"
-		"vinteger2d_t_erase(vinteger2d_t self, std::vector< std::vector< int > >::iterator pos) -> std::vector< std::vector< int > >::iterator\n"
-		"vinteger2d_t_erase(vinteger2d_t self, std::vector< std::vector< int > >::iterator first, std::vector< std::vector< int > >::iterator last) -> std::vector< std::vector< int > >::iterator\n"
+	 { "vinteger2d_T_pop", _wrap_vinteger2d_T_pop, METH_O, "vinteger2d_T_pop(vinteger2d_T self) -> vector_integer_T"},
+	 { "vinteger2d_T_append", _wrap_vinteger2d_T_append, METH_VARARGS, "vinteger2d_T_append(vinteger2d_T self, vector_integer_T x)"},
+	 { "vinteger2d_T_empty", _wrap_vinteger2d_T_empty, METH_O, "vinteger2d_T_empty(vinteger2d_T self) -> bool"},
+	 { "vinteger2d_T_size", _wrap_vinteger2d_T_size, METH_O, "vinteger2d_T_size(vinteger2d_T self) -> std::vector< std::vector< int > >::size_type"},
+	 { "vinteger2d_T_swap", _wrap_vinteger2d_T_swap, METH_VARARGS, "vinteger2d_T_swap(vinteger2d_T self, vinteger2d_T v)"},
+	 { "vinteger2d_T_begin", _wrap_vinteger2d_T_begin, METH_O, "vinteger2d_T_begin(vinteger2d_T self) -> std::vector< std::vector< int > >::iterator"},
+	 { "vinteger2d_T_end", _wrap_vinteger2d_T_end, METH_O, "vinteger2d_T_end(vinteger2d_T self) -> std::vector< std::vector< int > >::iterator"},
+	 { "vinteger2d_T_rbegin", _wrap_vinteger2d_T_rbegin, METH_O, "vinteger2d_T_rbegin(vinteger2d_T self) -> std::vector< std::vector< int > >::reverse_iterator"},
+	 { "vinteger2d_T_rend", _wrap_vinteger2d_T_rend, METH_O, "vinteger2d_T_rend(vinteger2d_T self) -> std::vector< std::vector< int > >::reverse_iterator"},
+	 { "vinteger2d_T_clear", _wrap_vinteger2d_T_clear, METH_O, "vinteger2d_T_clear(vinteger2d_T self)"},
+	 { "vinteger2d_T_get_allocator", _wrap_vinteger2d_T_get_allocator, METH_O, "vinteger2d_T_get_allocator(vinteger2d_T self) -> std::vector< std::vector< int > >::allocator_type"},
+	 { "vinteger2d_T_pop_back", _wrap_vinteger2d_T_pop_back, METH_O, "vinteger2d_T_pop_back(vinteger2d_T self)"},
+	 { "vinteger2d_T_erase", _wrap_vinteger2d_T_erase, METH_VARARGS, "\n"
+		"vinteger2d_T_erase(vinteger2d_T self, std::vector< std::vector< int > >::iterator pos) -> std::vector< std::vector< int > >::iterator\n"
+		"vinteger2d_T_erase(vinteger2d_T self, std::vector< std::vector< int > >::iterator first, std::vector< std::vector< int > >::iterator last) -> std::vector< std::vector< int > >::iterator\n"
 		""},
-	 { "new_vinteger2d_t", _wrap_new_vinteger2d_t, METH_VARARGS, "\n"
-		"vinteger2d_t()\n"
-		"vinteger2d_t(vinteger2d_t other)\n"
-		"vinteger2d_t(std::vector< std::vector< int > >::size_type size)\n"
-		"new_vinteger2d_t(std::vector< std::vector< int > >::size_type size, vector_integer_t value) -> vinteger2d_t\n"
+	 { "new_vinteger2d_T", _wrap_new_vinteger2d_T, METH_VARARGS, "\n"
+		"vinteger2d_T()\n"
+		"vinteger2d_T(vinteger2d_T other)\n"
+		"vinteger2d_T(std::vector< std::vector< int > >::size_type size)\n"
+		"new_vinteger2d_T(std::vector< std::vector< int > >::size_type size, vector_integer_T value) -> vinteger2d_T\n"
 		""},
-	 { "vinteger2d_t_push_back", _wrap_vinteger2d_t_push_back, METH_VARARGS, "vinteger2d_t_push_back(vinteger2d_t self, vector_integer_t x)"},
-	 { "vinteger2d_t_front", _wrap_vinteger2d_t_front, METH_O, "vinteger2d_t_front(vinteger2d_t self) -> vector_integer_t"},
-	 { "vinteger2d_t_back", _wrap_vinteger2d_t_back, METH_O, "vinteger2d_t_back(vinteger2d_t self) -> vector_integer_t"},
-	 { "vinteger2d_t_assign", _wrap_vinteger2d_t_assign, METH_VARARGS, "vinteger2d_t_assign(vinteger2d_t self, std::vector< std::vector< int > >::size_type n, vector_integer_t x)"},
-	 { "vinteger2d_t_resize", _wrap_vinteger2d_t_resize, METH_VARARGS, "\n"
-		"vinteger2d_t_resize(vinteger2d_t self, std::vector< std::vector< int > >::size_type new_size)\n"
-		"vinteger2d_t_resize(vinteger2d_t self, std::vector< std::vector< int > >::size_type new_size, vector_integer_t x)\n"
+	 { "vinteger2d_T_push_back", _wrap_vinteger2d_T_push_back, METH_VARARGS, "vinteger2d_T_push_back(vinteger2d_T self, vector_integer_T x)"},
+	 { "vinteger2d_T_front", _wrap_vinteger2d_T_front, METH_O, "vinteger2d_T_front(vinteger2d_T self) -> vector_integer_T"},
+	 { "vinteger2d_T_back", _wrap_vinteger2d_T_back, METH_O, "vinteger2d_T_back(vinteger2d_T self) -> vector_integer_T"},
+	 { "vinteger2d_T_assign", _wrap_vinteger2d_T_assign, METH_VARARGS, "vinteger2d_T_assign(vinteger2d_T self, std::vector< std::vector< int > >::size_type n, vector_integer_T x)"},
+	 { "vinteger2d_T_resize", _wrap_vinteger2d_T_resize, METH_VARARGS, "\n"
+		"vinteger2d_T_resize(vinteger2d_T self, std::vector< std::vector< int > >::size_type new_size)\n"
+		"vinteger2d_T_resize(vinteger2d_T self, std::vector< std::vector< int > >::size_type new_size, vector_integer_T x)\n"
 		""},
-	 { "vinteger2d_t_insert", _wrap_vinteger2d_t_insert, METH_VARARGS, "\n"
-		"vinteger2d_t_insert(vinteger2d_t self, std::vector< std::vector< int > >::iterator pos, vector_integer_t x) -> std::vector< std::vector< int > >::iterator\n"
-		"vinteger2d_t_insert(vinteger2d_t self, std::vector< std::vector< int > >::iterator pos, std::vector< std::vector< int > >::size_type n, vector_integer_t x)\n"
+	 { "vinteger2d_T_insert", _wrap_vinteger2d_T_insert, METH_VARARGS, "\n"
+		"vinteger2d_T_insert(vinteger2d_T self, std::vector< std::vector< int > >::iterator pos, vector_integer_T x) -> std::vector< std::vector< int > >::iterator\n"
+		"vinteger2d_T_insert(vinteger2d_T self, std::vector< std::vector< int > >::iterator pos, std::vector< std::vector< int > >::size_type n, vector_integer_T x)\n"
 		""},
-	 { "vinteger2d_t_reserve", _wrap_vinteger2d_t_reserve, METH_VARARGS, "vinteger2d_t_reserve(vinteger2d_t self, std::vector< std::vector< int > >::size_type n)"},
-	 { "vinteger2d_t_capacity", _wrap_vinteger2d_t_capacity, METH_O, "vinteger2d_t_capacity(vinteger2d_t self) -> std::vector< std::vector< int > >::size_type"},
-	 { "delete_vinteger2d_t", _wrap_delete_vinteger2d_t, METH_O, "delete_vinteger2d_t(vinteger2d_t self)"},
-	 { "vinteger2d_t_swigregister", vinteger2d_t_swigregister, METH_O, NULL},
-	 { "vinteger2d_t_swiginit", vinteger2d_t_swiginit, METH_VARARGS, NULL},
-	 { "vector_longinteger_t_iterator", _wrap_vector_longinteger_t_iterator, METH_O, "vector_longinteger_t_iterator(vector_longinteger_t self) -> SwigPyIterator"},
-	 { "vector_longinteger_t___nonzero__", _wrap_vector_longinteger_t___nonzero__, METH_O, "vector_longinteger_t___nonzero__(vector_longinteger_t self) -> bool"},
-	 { "vector_longinteger_t___bool__", _wrap_vector_longinteger_t___bool__, METH_O, "vector_longinteger_t___bool__(vector_longinteger_t self) -> bool"},
-	 { "vector_longinteger_t___len__", _wrap_vector_longinteger_t___len__, METH_O, "vector_longinteger_t___len__(vector_longinteger_t self) -> std::vector< unsigned long >::size_type"},
-	 { "vector_longinteger_t___getslice__", _wrap_vector_longinteger_t___getslice__, METH_VARARGS, "vector_longinteger_t___getslice__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j) -> vector_longinteger_t"},
-	 { "vector_longinteger_t___setslice__", _wrap_vector_longinteger_t___setslice__, METH_VARARGS, "\n"
-		"vector_longinteger_t___setslice__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j)\n"
-		"vector_longinteger_t___setslice__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j, vector_longinteger_t v)\n"
+	 { "vinteger2d_T_reserve", _wrap_vinteger2d_T_reserve, METH_VARARGS, "vinteger2d_T_reserve(vinteger2d_T self, std::vector< std::vector< int > >::size_type n)"},
+	 { "vinteger2d_T_capacity", _wrap_vinteger2d_T_capacity, METH_O, "vinteger2d_T_capacity(vinteger2d_T self) -> std::vector< std::vector< int > >::size_type"},
+	 { "delete_vinteger2d_T", _wrap_delete_vinteger2d_T, METH_O, "delete_vinteger2d_T(vinteger2d_T self)"},
+	 { "vinteger2d_T_swigregister", vinteger2d_T_swigregister, METH_O, NULL},
+	 { "vinteger2d_T_swiginit", vinteger2d_T_swiginit, METH_VARARGS, NULL},
+	 { "vector_longinteger_T_iterator", _wrap_vector_longinteger_T_iterator, METH_O, "vector_longinteger_T_iterator(vector_longinteger_T self) -> SwigPyIterator"},
+	 { "vector_longinteger_T___nonzero__", _wrap_vector_longinteger_T___nonzero__, METH_O, "vector_longinteger_T___nonzero__(vector_longinteger_T self) -> bool"},
+	 { "vector_longinteger_T___bool__", _wrap_vector_longinteger_T___bool__, METH_O, "vector_longinteger_T___bool__(vector_longinteger_T self) -> bool"},
+	 { "vector_longinteger_T___len__", _wrap_vector_longinteger_T___len__, METH_O, "vector_longinteger_T___len__(vector_longinteger_T self) -> std::vector< unsigned long >::size_type"},
+	 { "vector_longinteger_T___getslice__", _wrap_vector_longinteger_T___getslice__, METH_VARARGS, "vector_longinteger_T___getslice__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j) -> vector_longinteger_T"},
+	 { "vector_longinteger_T___setslice__", _wrap_vector_longinteger_T___setslice__, METH_VARARGS, "\n"
+		"vector_longinteger_T___setslice__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j)\n"
+		"vector_longinteger_T___setslice__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j, vector_longinteger_T v)\n"
 		""},
-	 { "vector_longinteger_t___delslice__", _wrap_vector_longinteger_t___delslice__, METH_VARARGS, "vector_longinteger_t___delslice__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j)"},
-	 { "vector_longinteger_t___delitem__", _wrap_vector_longinteger_t___delitem__, METH_VARARGS, "\n"
-		"vector_longinteger_t___delitem__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i)\n"
-		"vector_longinteger_t___delitem__(vector_longinteger_t self, SWIGPY_SLICEOBJECT * slice)\n"
+	 { "vector_longinteger_T___delslice__", _wrap_vector_longinteger_T___delslice__, METH_VARARGS, "vector_longinteger_T___delslice__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j)"},
+	 { "vector_longinteger_T___delitem__", _wrap_vector_longinteger_T___delitem__, METH_VARARGS, "\n"
+		"vector_longinteger_T___delitem__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i)\n"
+		"vector_longinteger_T___delitem__(vector_longinteger_T self, SWIGPY_SLICEOBJECT * slice)\n"
 		""},
-	 { "vector_longinteger_t___getitem__", _wrap_vector_longinteger_t___getitem__, METH_VARARGS, "\n"
-		"vector_longinteger_t___getitem__(vector_longinteger_t self, SWIGPY_SLICEOBJECT * slice) -> vector_longinteger_t\n"
-		"vector_longinteger_t___getitem__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i) -> std::vector< unsigned long >::value_type const &\n"
+	 { "vector_longinteger_T___getitem__", _wrap_vector_longinteger_T___getitem__, METH_VARARGS, "\n"
+		"vector_longinteger_T___getitem__(vector_longinteger_T self, SWIGPY_SLICEOBJECT * slice) -> vector_longinteger_T\n"
+		"vector_longinteger_T___getitem__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i) -> std::vector< unsigned long >::value_type const &\n"
 		""},
-	 { "vector_longinteger_t___setitem__", _wrap_vector_longinteger_t___setitem__, METH_VARARGS, "\n"
-		"vector_longinteger_t___setitem__(vector_longinteger_t self, SWIGPY_SLICEOBJECT * slice, vector_longinteger_t v)\n"
-		"vector_longinteger_t___setitem__(vector_longinteger_t self, SWIGPY_SLICEOBJECT * slice)\n"
-		"vector_longinteger_t___setitem__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::value_type const & x)\n"
+	 { "vector_longinteger_T___setitem__", _wrap_vector_longinteger_T___setitem__, METH_VARARGS, "\n"
+		"vector_longinteger_T___setitem__(vector_longinteger_T self, SWIGPY_SLICEOBJECT * slice, vector_longinteger_T v)\n"
+		"vector_longinteger_T___setitem__(vector_longinteger_T self, SWIGPY_SLICEOBJECT * slice)\n"
+		"vector_longinteger_T___setitem__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::value_type const & x)\n"
 		""},
-	 { "vector_longinteger_t_pop", _wrap_vector_longinteger_t_pop, METH_O, "vector_longinteger_t_pop(vector_longinteger_t self) -> std::vector< unsigned long >::value_type"},
-	 { "vector_longinteger_t_append", _wrap_vector_longinteger_t_append, METH_VARARGS, "vector_longinteger_t_append(vector_longinteger_t self, std::vector< unsigned long >::value_type const & x)"},
-	 { "vector_longinteger_t_empty", _wrap_vector_longinteger_t_empty, METH_O, "vector_longinteger_t_empty(vector_longinteger_t self) -> bool"},
-	 { "vector_longinteger_t_size", _wrap_vector_longinteger_t_size, METH_O, "vector_longinteger_t_size(vector_longinteger_t self) -> std::vector< unsigned long >::size_type"},
-	 { "vector_longinteger_t_swap", _wrap_vector_longinteger_t_swap, METH_VARARGS, "vector_longinteger_t_swap(vector_longinteger_t self, vector_longinteger_t v)"},
-	 { "vector_longinteger_t_begin", _wrap_vector_longinteger_t_begin, METH_O, "vector_longinteger_t_begin(vector_longinteger_t self) -> std::vector< unsigned long >::iterator"},
-	 { "vector_longinteger_t_end", _wrap_vector_longinteger_t_end, METH_O, "vector_longinteger_t_end(vector_longinteger_t self) -> std::vector< unsigned long >::iterator"},
-	 { "vector_longinteger_t_rbegin", _wrap_vector_longinteger_t_rbegin, METH_O, "vector_longinteger_t_rbegin(vector_longinteger_t self) -> std::vector< unsigned long >::reverse_iterator"},
-	 { "vector_longinteger_t_rend", _wrap_vector_longinteger_t_rend, METH_O, "vector_longinteger_t_rend(vector_longinteger_t self) -> std::vector< unsigned long >::reverse_iterator"},
-	 { "vector_longinteger_t_clear", _wrap_vector_longinteger_t_clear, METH_O, "vector_longinteger_t_clear(vector_longinteger_t self)"},
-	 { "vector_longinteger_t_get_allocator", _wrap_vector_longinteger_t_get_allocator, METH_O, "vector_longinteger_t_get_allocator(vector_longinteger_t self) -> std::vector< unsigned long >::allocator_type"},
-	 { "vector_longinteger_t_pop_back", _wrap_vector_longinteger_t_pop_back, METH_O, "vector_longinteger_t_pop_back(vector_longinteger_t self)"},
-	 { "vector_longinteger_t_erase", _wrap_vector_longinteger_t_erase, METH_VARARGS, "\n"
-		"vector_longinteger_t_erase(vector_longinteger_t self, std::vector< unsigned long >::iterator pos) -> std::vector< unsigned long >::iterator\n"
-		"vector_longinteger_t_erase(vector_longinteger_t self, std::vector< unsigned long >::iterator first, std::vector< unsigned long >::iterator last) -> std::vector< unsigned long >::iterator\n"
+	 { "vector_longinteger_T_pop", _wrap_vector_longinteger_T_pop, METH_O, "vector_longinteger_T_pop(vector_longinteger_T self) -> std::vector< unsigned long >::value_type"},
+	 { "vector_longinteger_T_append", _wrap_vector_longinteger_T_append, METH_VARARGS, "vector_longinteger_T_append(vector_longinteger_T self, std::vector< unsigned long >::value_type const & x)"},
+	 { "vector_longinteger_T_empty", _wrap_vector_longinteger_T_empty, METH_O, "vector_longinteger_T_empty(vector_longinteger_T self) -> bool"},
+	 { "vector_longinteger_T_size", _wrap_vector_longinteger_T_size, METH_O, "vector_longinteger_T_size(vector_longinteger_T self) -> std::vector< unsigned long >::size_type"},
+	 { "vector_longinteger_T_swap", _wrap_vector_longinteger_T_swap, METH_VARARGS, "vector_longinteger_T_swap(vector_longinteger_T self, vector_longinteger_T v)"},
+	 { "vector_longinteger_T_begin", _wrap_vector_longinteger_T_begin, METH_O, "vector_longinteger_T_begin(vector_longinteger_T self) -> std::vector< unsigned long >::iterator"},
+	 { "vector_longinteger_T_end", _wrap_vector_longinteger_T_end, METH_O, "vector_longinteger_T_end(vector_longinteger_T self) -> std::vector< unsigned long >::iterator"},
+	 { "vector_longinteger_T_rbegin", _wrap_vector_longinteger_T_rbegin, METH_O, "vector_longinteger_T_rbegin(vector_longinteger_T self) -> std::vector< unsigned long >::reverse_iterator"},
+	 { "vector_longinteger_T_rend", _wrap_vector_longinteger_T_rend, METH_O, "vector_longinteger_T_rend(vector_longinteger_T self) -> std::vector< unsigned long >::reverse_iterator"},
+	 { "vector_longinteger_T_clear", _wrap_vector_longinteger_T_clear, METH_O, "vector_longinteger_T_clear(vector_longinteger_T self)"},
+	 { "vector_longinteger_T_get_allocator", _wrap_vector_longinteger_T_get_allocator, METH_O, "vector_longinteger_T_get_allocator(vector_longinteger_T self) -> std::vector< unsigned long >::allocator_type"},
+	 { "vector_longinteger_T_pop_back", _wrap_vector_longinteger_T_pop_back, METH_O, "vector_longinteger_T_pop_back(vector_longinteger_T self)"},
+	 { "vector_longinteger_T_erase", _wrap_vector_longinteger_T_erase, METH_VARARGS, "\n"
+		"vector_longinteger_T_erase(vector_longinteger_T self, std::vector< unsigned long >::iterator pos) -> std::vector< unsigned long >::iterator\n"
+		"vector_longinteger_T_erase(vector_longinteger_T self, std::vector< unsigned long >::iterator first, std::vector< unsigned long >::iterator last) -> std::vector< unsigned long >::iterator\n"
 		""},
-	 { "new_vector_longinteger_t", _wrap_new_vector_longinteger_t, METH_VARARGS, "\n"
-		"vector_longinteger_t()\n"
-		"vector_longinteger_t(vector_longinteger_t other)\n"
-		"vector_longinteger_t(std::vector< unsigned long >::size_type size)\n"
-		"new_vector_longinteger_t(std::vector< unsigned long >::size_type size, std::vector< unsigned long >::value_type const & value) -> vector_longinteger_t\n"
+	 { "new_vector_longinteger_T", _wrap_new_vector_longinteger_T, METH_VARARGS, "\n"
+		"vector_longinteger_T()\n"
+		"vector_longinteger_T(vector_longinteger_T other)\n"
+		"vector_longinteger_T(std::vector< unsigned long >::size_type size)\n"
+		"new_vector_longinteger_T(std::vector< unsigned long >::size_type size, std::vector< unsigned long >::value_type const & value) -> vector_longinteger_T\n"
 		""},
-	 { "vector_longinteger_t_push_back", _wrap_vector_longinteger_t_push_back, METH_VARARGS, "vector_longinteger_t_push_back(vector_longinteger_t self, std::vector< unsigned long >::value_type const & x)"},
-	 { "vector_longinteger_t_front", _wrap_vector_longinteger_t_front, METH_O, "vector_longinteger_t_front(vector_longinteger_t self) -> std::vector< unsigned long >::value_type const &"},
-	 { "vector_longinteger_t_back", _wrap_vector_longinteger_t_back, METH_O, "vector_longinteger_t_back(vector_longinteger_t self) -> std::vector< unsigned long >::value_type const &"},
-	 { "vector_longinteger_t_assign", _wrap_vector_longinteger_t_assign, METH_VARARGS, "vector_longinteger_t_assign(vector_longinteger_t self, std::vector< unsigned long >::size_type n, std::vector< unsigned long >::value_type const & x)"},
-	 { "vector_longinteger_t_resize", _wrap_vector_longinteger_t_resize, METH_VARARGS, "\n"
-		"vector_longinteger_t_resize(vector_longinteger_t self, std::vector< unsigned long >::size_type new_size)\n"
-		"vector_longinteger_t_resize(vector_longinteger_t self, std::vector< unsigned long >::size_type new_size, std::vector< unsigned long >::value_type const & x)\n"
+	 { "vector_longinteger_T_push_back", _wrap_vector_longinteger_T_push_back, METH_VARARGS, "vector_longinteger_T_push_back(vector_longinteger_T self, std::vector< unsigned long >::value_type const & x)"},
+	 { "vector_longinteger_T_front", _wrap_vector_longinteger_T_front, METH_O, "vector_longinteger_T_front(vector_longinteger_T self) -> std::vector< unsigned long >::value_type const &"},
+	 { "vector_longinteger_T_back", _wrap_vector_longinteger_T_back, METH_O, "vector_longinteger_T_back(vector_longinteger_T self) -> std::vector< unsigned long >::value_type const &"},
+	 { "vector_longinteger_T_assign", _wrap_vector_longinteger_T_assign, METH_VARARGS, "vector_longinteger_T_assign(vector_longinteger_T self, std::vector< unsigned long >::size_type n, std::vector< unsigned long >::value_type const & x)"},
+	 { "vector_longinteger_T_resize", _wrap_vector_longinteger_T_resize, METH_VARARGS, "\n"
+		"vector_longinteger_T_resize(vector_longinteger_T self, std::vector< unsigned long >::size_type new_size)\n"
+		"vector_longinteger_T_resize(vector_longinteger_T self, std::vector< unsigned long >::size_type new_size, std::vector< unsigned long >::value_type const & x)\n"
 		""},
-	 { "vector_longinteger_t_insert", _wrap_vector_longinteger_t_insert, METH_VARARGS, "\n"
-		"vector_longinteger_t_insert(vector_longinteger_t self, std::vector< unsigned long >::iterator pos, std::vector< unsigned long >::value_type const & x) -> std::vector< unsigned long >::iterator\n"
-		"vector_longinteger_t_insert(vector_longinteger_t self, std::vector< unsigned long >::iterator pos, std::vector< unsigned long >::size_type n, std::vector< unsigned long >::value_type const & x)\n"
+	 { "vector_longinteger_T_insert", _wrap_vector_longinteger_T_insert, METH_VARARGS, "\n"
+		"vector_longinteger_T_insert(vector_longinteger_T self, std::vector< unsigned long >::iterator pos, std::vector< unsigned long >::value_type const & x) -> std::vector< unsigned long >::iterator\n"
+		"vector_longinteger_T_insert(vector_longinteger_T self, std::vector< unsigned long >::iterator pos, std::vector< unsigned long >::size_type n, std::vector< unsigned long >::value_type const & x)\n"
 		""},
-	 { "vector_longinteger_t_reserve", _wrap_vector_longinteger_t_reserve, METH_VARARGS, "vector_longinteger_t_reserve(vector_longinteger_t self, std::vector< unsigned long >::size_type n)"},
-	 { "vector_longinteger_t_capacity", _wrap_vector_longinteger_t_capacity, METH_O, "vector_longinteger_t_capacity(vector_longinteger_t self) -> std::vector< unsigned long >::size_type"},
-	 { "delete_vector_longinteger_t", _wrap_delete_vector_longinteger_t, METH_O, "delete_vector_longinteger_t(vector_longinteger_t self)"},
-	 { "vector_longinteger_t_swigregister", vector_longinteger_t_swigregister, METH_O, NULL},
-	 { "vector_longinteger_t_swiginit", vector_longinteger_t_swiginit, METH_VARARGS, NULL},
-	 { "vector_complex_t_iterator", _wrap_vector_complex_t_iterator, METH_O, "vector_complex_t_iterator(vector_complex_t self) -> SwigPyIterator"},
-	 { "vector_complex_t___nonzero__", _wrap_vector_complex_t___nonzero__, METH_O, "vector_complex_t___nonzero__(vector_complex_t self) -> bool"},
-	 { "vector_complex_t___bool__", _wrap_vector_complex_t___bool__, METH_O, "vector_complex_t___bool__(vector_complex_t self) -> bool"},
-	 { "vector_complex_t___len__", _wrap_vector_complex_t___len__, METH_O, "vector_complex_t___len__(vector_complex_t self) -> std::vector< std::complex< double > >::size_type"},
-	 { "vector_complex_t___getslice__", _wrap_vector_complex_t___getslice__, METH_VARARGS, "vector_complex_t___getslice__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j) -> vector_complex_t"},
-	 { "vector_complex_t___setslice__", _wrap_vector_complex_t___setslice__, METH_VARARGS, "\n"
-		"vector_complex_t___setslice__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j)\n"
-		"vector_complex_t___setslice__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j, vector_complex_t v)\n"
+	 { "vector_longinteger_T_reserve", _wrap_vector_longinteger_T_reserve, METH_VARARGS, "vector_longinteger_T_reserve(vector_longinteger_T self, std::vector< unsigned long >::size_type n)"},
+	 { "vector_longinteger_T_capacity", _wrap_vector_longinteger_T_capacity, METH_O, "vector_longinteger_T_capacity(vector_longinteger_T self) -> std::vector< unsigned long >::size_type"},
+	 { "delete_vector_longinteger_T", _wrap_delete_vector_longinteger_T, METH_O, "delete_vector_longinteger_T(vector_longinteger_T self)"},
+	 { "vector_longinteger_T_swigregister", vector_longinteger_T_swigregister, METH_O, NULL},
+	 { "vector_longinteger_T_swiginit", vector_longinteger_T_swiginit, METH_VARARGS, NULL},
+	 { "vector_complex_T_iterator", _wrap_vector_complex_T_iterator, METH_O, "vector_complex_T_iterator(vector_complex_T self) -> SwigPyIterator"},
+	 { "vector_complex_T___nonzero__", _wrap_vector_complex_T___nonzero__, METH_O, "vector_complex_T___nonzero__(vector_complex_T self) -> bool"},
+	 { "vector_complex_T___bool__", _wrap_vector_complex_T___bool__, METH_O, "vector_complex_T___bool__(vector_complex_T self) -> bool"},
+	 { "vector_complex_T___len__", _wrap_vector_complex_T___len__, METH_O, "vector_complex_T___len__(vector_complex_T self) -> std::vector< std::complex< double > >::size_type"},
+	 { "vector_complex_T___getslice__", _wrap_vector_complex_T___getslice__, METH_VARARGS, "vector_complex_T___getslice__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j) -> vector_complex_T"},
+	 { "vector_complex_T___setslice__", _wrap_vector_complex_T___setslice__, METH_VARARGS, "\n"
+		"vector_complex_T___setslice__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j)\n"
+		"vector_complex_T___setslice__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j, vector_complex_T v)\n"
 		""},
-	 { "vector_complex_t___delslice__", _wrap_vector_complex_t___delslice__, METH_VARARGS, "vector_complex_t___delslice__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j)"},
-	 { "vector_complex_t___delitem__", _wrap_vector_complex_t___delitem__, METH_VARARGS, "\n"
-		"vector_complex_t___delitem__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i)\n"
-		"vector_complex_t___delitem__(vector_complex_t self, SWIGPY_SLICEOBJECT * slice)\n"
+	 { "vector_complex_T___delslice__", _wrap_vector_complex_T___delslice__, METH_VARARGS, "vector_complex_T___delslice__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j)"},
+	 { "vector_complex_T___delitem__", _wrap_vector_complex_T___delitem__, METH_VARARGS, "\n"
+		"vector_complex_T___delitem__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i)\n"
+		"vector_complex_T___delitem__(vector_complex_T self, SWIGPY_SLICEOBJECT * slice)\n"
 		""},
-	 { "vector_complex_t___getitem__", _wrap_vector_complex_t___getitem__, METH_VARARGS, "\n"
-		"vector_complex_t___getitem__(vector_complex_t self, SWIGPY_SLICEOBJECT * slice) -> vector_complex_t\n"
-		"vector_complex_t___getitem__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i) -> std::vector< std::complex< double > >::value_type const &\n"
+	 { "vector_complex_T___getitem__", _wrap_vector_complex_T___getitem__, METH_VARARGS, "\n"
+		"vector_complex_T___getitem__(vector_complex_T self, SWIGPY_SLICEOBJECT * slice) -> vector_complex_T\n"
+		"vector_complex_T___getitem__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i) -> std::vector< std::complex< double > >::value_type const &\n"
 		""},
-	 { "vector_complex_t___setitem__", _wrap_vector_complex_t___setitem__, METH_VARARGS, "\n"
-		"vector_complex_t___setitem__(vector_complex_t self, SWIGPY_SLICEOBJECT * slice, vector_complex_t v)\n"
-		"vector_complex_t___setitem__(vector_complex_t self, SWIGPY_SLICEOBJECT * slice)\n"
-		"vector_complex_t___setitem__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::value_type const & x)\n"
+	 { "vector_complex_T___setitem__", _wrap_vector_complex_T___setitem__, METH_VARARGS, "\n"
+		"vector_complex_T___setitem__(vector_complex_T self, SWIGPY_SLICEOBJECT * slice, vector_complex_T v)\n"
+		"vector_complex_T___setitem__(vector_complex_T self, SWIGPY_SLICEOBJECT * slice)\n"
+		"vector_complex_T___setitem__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::value_type const & x)\n"
 		""},
-	 { "vector_complex_t_pop", _wrap_vector_complex_t_pop, METH_O, "vector_complex_t_pop(vector_complex_t self) -> std::vector< std::complex< double > >::value_type"},
-	 { "vector_complex_t_append", _wrap_vector_complex_t_append, METH_VARARGS, "vector_complex_t_append(vector_complex_t self, std::vector< std::complex< double > >::value_type const & x)"},
-	 { "vector_complex_t_empty", _wrap_vector_complex_t_empty, METH_O, "vector_complex_t_empty(vector_complex_t self) -> bool"},
-	 { "vector_complex_t_size", _wrap_vector_complex_t_size, METH_O, "vector_complex_t_size(vector_complex_t self) -> std::vector< std::complex< double > >::size_type"},
-	 { "vector_complex_t_swap", _wrap_vector_complex_t_swap, METH_VARARGS, "vector_complex_t_swap(vector_complex_t self, vector_complex_t v)"},
-	 { "vector_complex_t_begin", _wrap_vector_complex_t_begin, METH_O, "vector_complex_t_begin(vector_complex_t self) -> std::vector< std::complex< double > >::iterator"},
-	 { "vector_complex_t_end", _wrap_vector_complex_t_end, METH_O, "vector_complex_t_end(vector_complex_t self) -> std::vector< std::complex< double > >::iterator"},
-	 { "vector_complex_t_rbegin", _wrap_vector_complex_t_rbegin, METH_O, "vector_complex_t_rbegin(vector_complex_t self) -> std::vector< std::complex< double > >::reverse_iterator"},
-	 { "vector_complex_t_rend", _wrap_vector_complex_t_rend, METH_O, "vector_complex_t_rend(vector_complex_t self) -> std::vector< std::complex< double > >::reverse_iterator"},
-	 { "vector_complex_t_clear", _wrap_vector_complex_t_clear, METH_O, "vector_complex_t_clear(vector_complex_t self)"},
-	 { "vector_complex_t_get_allocator", _wrap_vector_complex_t_get_allocator, METH_O, "vector_complex_t_get_allocator(vector_complex_t self) -> std::vector< std::complex< double > >::allocator_type"},
-	 { "vector_complex_t_pop_back", _wrap_vector_complex_t_pop_back, METH_O, "vector_complex_t_pop_back(vector_complex_t self)"},
-	 { "vector_complex_t_erase", _wrap_vector_complex_t_erase, METH_VARARGS, "\n"
-		"vector_complex_t_erase(vector_complex_t self, std::vector< std::complex< double > >::iterator pos) -> std::vector< std::complex< double > >::iterator\n"
-		"vector_complex_t_erase(vector_complex_t self, std::vector< std::complex< double > >::iterator first, std::vector< std::complex< double > >::iterator last) -> std::vector< std::complex< double > >::iterator\n"
+	 { "vector_complex_T_pop", _wrap_vector_complex_T_pop, METH_O, "vector_complex_T_pop(vector_complex_T self) -> std::vector< std::complex< double > >::value_type"},
+	 { "vector_complex_T_append", _wrap_vector_complex_T_append, METH_VARARGS, "vector_complex_T_append(vector_complex_T self, std::vector< std::complex< double > >::value_type const & x)"},
+	 { "vector_complex_T_empty", _wrap_vector_complex_T_empty, METH_O, "vector_complex_T_empty(vector_complex_T self) -> bool"},
+	 { "vector_complex_T_size", _wrap_vector_complex_T_size, METH_O, "vector_complex_T_size(vector_complex_T self) -> std::vector< std::complex< double > >::size_type"},
+	 { "vector_complex_T_swap", _wrap_vector_complex_T_swap, METH_VARARGS, "vector_complex_T_swap(vector_complex_T self, vector_complex_T v)"},
+	 { "vector_complex_T_begin", _wrap_vector_complex_T_begin, METH_O, "vector_complex_T_begin(vector_complex_T self) -> std::vector< std::complex< double > >::iterator"},
+	 { "vector_complex_T_end", _wrap_vector_complex_T_end, METH_O, "vector_complex_T_end(vector_complex_T self) -> std::vector< std::complex< double > >::iterator"},
+	 { "vector_complex_T_rbegin", _wrap_vector_complex_T_rbegin, METH_O, "vector_complex_T_rbegin(vector_complex_T self) -> std::vector< std::complex< double > >::reverse_iterator"},
+	 { "vector_complex_T_rend", _wrap_vector_complex_T_rend, METH_O, "vector_complex_T_rend(vector_complex_T self) -> std::vector< std::complex< double > >::reverse_iterator"},
+	 { "vector_complex_T_clear", _wrap_vector_complex_T_clear, METH_O, "vector_complex_T_clear(vector_complex_T self)"},
+	 { "vector_complex_T_get_allocator", _wrap_vector_complex_T_get_allocator, METH_O, "vector_complex_T_get_allocator(vector_complex_T self) -> std::vector< std::complex< double > >::allocator_type"},
+	 { "vector_complex_T_pop_back", _wrap_vector_complex_T_pop_back, METH_O, "vector_complex_T_pop_back(vector_complex_T self)"},
+	 { "vector_complex_T_erase", _wrap_vector_complex_T_erase, METH_VARARGS, "\n"
+		"vector_complex_T_erase(vector_complex_T self, std::vector< std::complex< double > >::iterator pos) -> std::vector< std::complex< double > >::iterator\n"
+		"vector_complex_T_erase(vector_complex_T self, std::vector< std::complex< double > >::iterator first, std::vector< std::complex< double > >::iterator last) -> std::vector< std::complex< double > >::iterator\n"
 		""},
-	 { "new_vector_complex_t", _wrap_new_vector_complex_t, METH_VARARGS, "\n"
-		"vector_complex_t()\n"
-		"vector_complex_t(vector_complex_t other)\n"
-		"vector_complex_t(std::vector< std::complex< double > >::size_type size)\n"
-		"new_vector_complex_t(std::vector< std::complex< double > >::size_type size, std::vector< std::complex< double > >::value_type const & value) -> vector_complex_t\n"
+	 { "new_vector_complex_T", _wrap_new_vector_complex_T, METH_VARARGS, "\n"
+		"vector_complex_T()\n"
+		"vector_complex_T(vector_complex_T other)\n"
+		"vector_complex_T(std::vector< std::complex< double > >::size_type size)\n"
+		"new_vector_complex_T(std::vector< std::complex< double > >::size_type size, std::vector< std::complex< double > >::value_type const & value) -> vector_complex_T\n"
 		""},
-	 { "vector_complex_t_push_back", _wrap_vector_complex_t_push_back, METH_VARARGS, "vector_complex_t_push_back(vector_complex_t self, std::vector< std::complex< double > >::value_type const & x)"},
-	 { "vector_complex_t_front", _wrap_vector_complex_t_front, METH_O, "vector_complex_t_front(vector_complex_t self) -> std::vector< std::complex< double > >::value_type const &"},
-	 { "vector_complex_t_back", _wrap_vector_complex_t_back, METH_O, "vector_complex_t_back(vector_complex_t self) -> std::vector< std::complex< double > >::value_type const &"},
-	 { "vector_complex_t_assign", _wrap_vector_complex_t_assign, METH_VARARGS, "vector_complex_t_assign(vector_complex_t self, std::vector< std::complex< double > >::size_type n, std::vector< std::complex< double > >::value_type const & x)"},
-	 { "vector_complex_t_resize", _wrap_vector_complex_t_resize, METH_VARARGS, "\n"
-		"vector_complex_t_resize(vector_complex_t self, std::vector< std::complex< double > >::size_type new_size)\n"
-		"vector_complex_t_resize(vector_complex_t self, std::vector< std::complex< double > >::size_type new_size, std::vector< std::complex< double > >::value_type const & x)\n"
+	 { "vector_complex_T_push_back", _wrap_vector_complex_T_push_back, METH_VARARGS, "vector_complex_T_push_back(vector_complex_T self, std::vector< std::complex< double > >::value_type const & x)"},
+	 { "vector_complex_T_front", _wrap_vector_complex_T_front, METH_O, "vector_complex_T_front(vector_complex_T self) -> std::vector< std::complex< double > >::value_type const &"},
+	 { "vector_complex_T_back", _wrap_vector_complex_T_back, METH_O, "vector_complex_T_back(vector_complex_T self) -> std::vector< std::complex< double > >::value_type const &"},
+	 { "vector_complex_T_assign", _wrap_vector_complex_T_assign, METH_VARARGS, "vector_complex_T_assign(vector_complex_T self, std::vector< std::complex< double > >::size_type n, std::vector< std::complex< double > >::value_type const & x)"},
+	 { "vector_complex_T_resize", _wrap_vector_complex_T_resize, METH_VARARGS, "\n"
+		"vector_complex_T_resize(vector_complex_T self, std::vector< std::complex< double > >::size_type new_size)\n"
+		"vector_complex_T_resize(vector_complex_T self, std::vector< std::complex< double > >::size_type new_size, std::vector< std::complex< double > >::value_type const & x)\n"
 		""},
-	 { "vector_complex_t_insert", _wrap_vector_complex_t_insert, METH_VARARGS, "\n"
-		"vector_complex_t_insert(vector_complex_t self, std::vector< std::complex< double > >::iterator pos, std::vector< std::complex< double > >::value_type const & x) -> std::vector< std::complex< double > >::iterator\n"
-		"vector_complex_t_insert(vector_complex_t self, std::vector< std::complex< double > >::iterator pos, std::vector< std::complex< double > >::size_type n, std::vector< std::complex< double > >::value_type const & x)\n"
+	 { "vector_complex_T_insert", _wrap_vector_complex_T_insert, METH_VARARGS, "\n"
+		"vector_complex_T_insert(vector_complex_T self, std::vector< std::complex< double > >::iterator pos, std::vector< std::complex< double > >::value_type const & x) -> std::vector< std::complex< double > >::iterator\n"
+		"vector_complex_T_insert(vector_complex_T self, std::vector< std::complex< double > >::iterator pos, std::vector< std::complex< double > >::size_type n, std::vector< std::complex< double > >::value_type const & x)\n"
 		""},
-	 { "vector_complex_t_reserve", _wrap_vector_complex_t_reserve, METH_VARARGS, "vector_complex_t_reserve(vector_complex_t self, std::vector< std::complex< double > >::size_type n)"},
-	 { "vector_complex_t_capacity", _wrap_vector_complex_t_capacity, METH_O, "vector_complex_t_capacity(vector_complex_t self) -> std::vector< std::complex< double > >::size_type"},
-	 { "delete_vector_complex_t", _wrap_delete_vector_complex_t, METH_O, "delete_vector_complex_t(vector_complex_t self)"},
-	 { "vector_complex_t_swigregister", vector_complex_t_swigregister, METH_O, NULL},
-	 { "vector_complex_t_swiginit", vector_complex_t_swiginit, METH_VARARGS, NULL},
-	 { "vector_string_t_iterator", _wrap_vector_string_t_iterator, METH_O, "vector_string_t_iterator(vector_string_t self) -> SwigPyIterator"},
-	 { "vector_string_t___nonzero__", _wrap_vector_string_t___nonzero__, METH_O, "vector_string_t___nonzero__(vector_string_t self) -> bool"},
-	 { "vector_string_t___bool__", _wrap_vector_string_t___bool__, METH_O, "vector_string_t___bool__(vector_string_t self) -> bool"},
-	 { "vector_string_t___len__", _wrap_vector_string_t___len__, METH_O, "vector_string_t___len__(vector_string_t self) -> std::vector< std::string >::size_type"},
-	 { "vector_string_t___getslice__", _wrap_vector_string_t___getslice__, METH_VARARGS, "vector_string_t___getslice__(vector_string_t self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j) -> vector_string_t"},
-	 { "vector_string_t___setslice__", _wrap_vector_string_t___setslice__, METH_VARARGS, "\n"
-		"vector_string_t___setslice__(vector_string_t self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j)\n"
-		"vector_string_t___setslice__(vector_string_t self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j, vector_string_t v)\n"
+	 { "vector_complex_T_reserve", _wrap_vector_complex_T_reserve, METH_VARARGS, "vector_complex_T_reserve(vector_complex_T self, std::vector< std::complex< double > >::size_type n)"},
+	 { "vector_complex_T_capacity", _wrap_vector_complex_T_capacity, METH_O, "vector_complex_T_capacity(vector_complex_T self) -> std::vector< std::complex< double > >::size_type"},
+	 { "delete_vector_complex_T", _wrap_delete_vector_complex_T, METH_O, "delete_vector_complex_T(vector_complex_T self)"},
+	 { "vector_complex_T_swigregister", vector_complex_T_swigregister, METH_O, NULL},
+	 { "vector_complex_T_swiginit", vector_complex_T_swiginit, METH_VARARGS, NULL},
+	 { "vector_string_T_iterator", _wrap_vector_string_T_iterator, METH_O, "vector_string_T_iterator(vector_string_T self) -> SwigPyIterator"},
+	 { "vector_string_T___nonzero__", _wrap_vector_string_T___nonzero__, METH_O, "vector_string_T___nonzero__(vector_string_T self) -> bool"},
+	 { "vector_string_T___bool__", _wrap_vector_string_T___bool__, METH_O, "vector_string_T___bool__(vector_string_T self) -> bool"},
+	 { "vector_string_T___len__", _wrap_vector_string_T___len__, METH_O, "vector_string_T___len__(vector_string_T self) -> std::vector< std::string >::size_type"},
+	 { "vector_string_T___getslice__", _wrap_vector_string_T___getslice__, METH_VARARGS, "vector_string_T___getslice__(vector_string_T self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j) -> vector_string_T"},
+	 { "vector_string_T___setslice__", _wrap_vector_string_T___setslice__, METH_VARARGS, "\n"
+		"vector_string_T___setslice__(vector_string_T self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j)\n"
+		"vector_string_T___setslice__(vector_string_T self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j, vector_string_T v)\n"
 		""},
-	 { "vector_string_t___delslice__", _wrap_vector_string_t___delslice__, METH_VARARGS, "vector_string_t___delslice__(vector_string_t self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j)"},
-	 { "vector_string_t___delitem__", _wrap_vector_string_t___delitem__, METH_VARARGS, "\n"
-		"vector_string_t___delitem__(vector_string_t self, std::vector< std::string >::difference_type i)\n"
-		"vector_string_t___delitem__(vector_string_t self, SWIGPY_SLICEOBJECT * slice)\n"
+	 { "vector_string_T___delslice__", _wrap_vector_string_T___delslice__, METH_VARARGS, "vector_string_T___delslice__(vector_string_T self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j)"},
+	 { "vector_string_T___delitem__", _wrap_vector_string_T___delitem__, METH_VARARGS, "\n"
+		"vector_string_T___delitem__(vector_string_T self, std::vector< std::string >::difference_type i)\n"
+		"vector_string_T___delitem__(vector_string_T self, SWIGPY_SLICEOBJECT * slice)\n"
 		""},
-	 { "vector_string_t___getitem__", _wrap_vector_string_t___getitem__, METH_VARARGS, "\n"
-		"vector_string_t___getitem__(vector_string_t self, SWIGPY_SLICEOBJECT * slice) -> vector_string_t\n"
-		"vector_string_t___getitem__(vector_string_t self, std::vector< std::string >::difference_type i) -> std::vector< std::string >::value_type const &\n"
+	 { "vector_string_T___getitem__", _wrap_vector_string_T___getitem__, METH_VARARGS, "\n"
+		"vector_string_T___getitem__(vector_string_T self, SWIGPY_SLICEOBJECT * slice) -> vector_string_T\n"
+		"vector_string_T___getitem__(vector_string_T self, std::vector< std::string >::difference_type i) -> std::vector< std::string >::value_type const &\n"
 		""},
-	 { "vector_string_t___setitem__", _wrap_vector_string_t___setitem__, METH_VARARGS, "\n"
-		"vector_string_t___setitem__(vector_string_t self, SWIGPY_SLICEOBJECT * slice, vector_string_t v)\n"
-		"vector_string_t___setitem__(vector_string_t self, SWIGPY_SLICEOBJECT * slice)\n"
-		"vector_string_t___setitem__(vector_string_t self, std::vector< std::string >::difference_type i, std::vector< std::string >::value_type const & x)\n"
+	 { "vector_string_T___setitem__", _wrap_vector_string_T___setitem__, METH_VARARGS, "\n"
+		"vector_string_T___setitem__(vector_string_T self, SWIGPY_SLICEOBJECT * slice, vector_string_T v)\n"
+		"vector_string_T___setitem__(vector_string_T self, SWIGPY_SLICEOBJECT * slice)\n"
+		"vector_string_T___setitem__(vector_string_T self, std::vector< std::string >::difference_type i, std::vector< std::string >::value_type const & x)\n"
 		""},
-	 { "vector_string_t_pop", _wrap_vector_string_t_pop, METH_O, "vector_string_t_pop(vector_string_t self) -> std::vector< std::string >::value_type"},
-	 { "vector_string_t_append", _wrap_vector_string_t_append, METH_VARARGS, "vector_string_t_append(vector_string_t self, std::vector< std::string >::value_type const & x)"},
-	 { "vector_string_t_empty", _wrap_vector_string_t_empty, METH_O, "vector_string_t_empty(vector_string_t self) -> bool"},
-	 { "vector_string_t_size", _wrap_vector_string_t_size, METH_O, "vector_string_t_size(vector_string_t self) -> std::vector< std::string >::size_type"},
-	 { "vector_string_t_swap", _wrap_vector_string_t_swap, METH_VARARGS, "vector_string_t_swap(vector_string_t self, vector_string_t v)"},
-	 { "vector_string_t_begin", _wrap_vector_string_t_begin, METH_O, "vector_string_t_begin(vector_string_t self) -> std::vector< std::string >::iterator"},
-	 { "vector_string_t_end", _wrap_vector_string_t_end, METH_O, "vector_string_t_end(vector_string_t self) -> std::vector< std::string >::iterator"},
-	 { "vector_string_t_rbegin", _wrap_vector_string_t_rbegin, METH_O, "vector_string_t_rbegin(vector_string_t self) -> std::vector< std::string >::reverse_iterator"},
-	 { "vector_string_t_rend", _wrap_vector_string_t_rend, METH_O, "vector_string_t_rend(vector_string_t self) -> std::vector< std::string >::reverse_iterator"},
-	 { "vector_string_t_clear", _wrap_vector_string_t_clear, METH_O, "vector_string_t_clear(vector_string_t self)"},
-	 { "vector_string_t_get_allocator", _wrap_vector_string_t_get_allocator, METH_O, "vector_string_t_get_allocator(vector_string_t self) -> std::vector< std::string >::allocator_type"},
-	 { "vector_string_t_pop_back", _wrap_vector_string_t_pop_back, METH_O, "vector_string_t_pop_back(vector_string_t self)"},
-	 { "vector_string_t_erase", _wrap_vector_string_t_erase, METH_VARARGS, "\n"
-		"vector_string_t_erase(vector_string_t self, std::vector< std::string >::iterator pos) -> std::vector< std::string >::iterator\n"
-		"vector_string_t_erase(vector_string_t self, std::vector< std::string >::iterator first, std::vector< std::string >::iterator last) -> std::vector< std::string >::iterator\n"
+	 { "vector_string_T_pop", _wrap_vector_string_T_pop, METH_O, "vector_string_T_pop(vector_string_T self) -> std::vector< std::string >::value_type"},
+	 { "vector_string_T_append", _wrap_vector_string_T_append, METH_VARARGS, "vector_string_T_append(vector_string_T self, std::vector< std::string >::value_type const & x)"},
+	 { "vector_string_T_empty", _wrap_vector_string_T_empty, METH_O, "vector_string_T_empty(vector_string_T self) -> bool"},
+	 { "vector_string_T_size", _wrap_vector_string_T_size, METH_O, "vector_string_T_size(vector_string_T self) -> std::vector< std::string >::size_type"},
+	 { "vector_string_T_swap", _wrap_vector_string_T_swap, METH_VARARGS, "vector_string_T_swap(vector_string_T self, vector_string_T v)"},
+	 { "vector_string_T_begin", _wrap_vector_string_T_begin, METH_O, "vector_string_T_begin(vector_string_T self) -> std::vector< std::string >::iterator"},
+	 { "vector_string_T_end", _wrap_vector_string_T_end, METH_O, "vector_string_T_end(vector_string_T self) -> std::vector< std::string >::iterator"},
+	 { "vector_string_T_rbegin", _wrap_vector_string_T_rbegin, METH_O, "vector_string_T_rbegin(vector_string_T self) -> std::vector< std::string >::reverse_iterator"},
+	 { "vector_string_T_rend", _wrap_vector_string_T_rend, METH_O, "vector_string_T_rend(vector_string_T self) -> std::vector< std::string >::reverse_iterator"},
+	 { "vector_string_T_clear", _wrap_vector_string_T_clear, METH_O, "vector_string_T_clear(vector_string_T self)"},
+	 { "vector_string_T_get_allocator", _wrap_vector_string_T_get_allocator, METH_O, "vector_string_T_get_allocator(vector_string_T self) -> std::vector< std::string >::allocator_type"},
+	 { "vector_string_T_pop_back", _wrap_vector_string_T_pop_back, METH_O, "vector_string_T_pop_back(vector_string_T self)"},
+	 { "vector_string_T_erase", _wrap_vector_string_T_erase, METH_VARARGS, "\n"
+		"vector_string_T_erase(vector_string_T self, std::vector< std::string >::iterator pos) -> std::vector< std::string >::iterator\n"
+		"vector_string_T_erase(vector_string_T self, std::vector< std::string >::iterator first, std::vector< std::string >::iterator last) -> std::vector< std::string >::iterator\n"
 		""},
-	 { "new_vector_string_t", _wrap_new_vector_string_t, METH_VARARGS, "\n"
-		"vector_string_t()\n"
-		"vector_string_t(vector_string_t other)\n"
-		"vector_string_t(std::vector< std::string >::size_type size)\n"
-		"new_vector_string_t(std::vector< std::string >::size_type size, std::vector< std::string >::value_type const & value) -> vector_string_t\n"
+	 { "new_vector_string_T", _wrap_new_vector_string_T, METH_VARARGS, "\n"
+		"vector_string_T()\n"
+		"vector_string_T(vector_string_T other)\n"
+		"vector_string_T(std::vector< std::string >::size_type size)\n"
+		"new_vector_string_T(std::vector< std::string >::size_type size, std::vector< std::string >::value_type const & value) -> vector_string_T\n"
 		""},
-	 { "vector_string_t_push_back", _wrap_vector_string_t_push_back, METH_VARARGS, "vector_string_t_push_back(vector_string_t self, std::vector< std::string >::value_type const & x)"},
-	 { "vector_string_t_front", _wrap_vector_string_t_front, METH_O, "vector_string_t_front(vector_string_t self) -> std::vector< std::string >::value_type const &"},
-	 { "vector_string_t_back", _wrap_vector_string_t_back, METH_O, "vector_string_t_back(vector_string_t self) -> std::vector< std::string >::value_type const &"},
-	 { "vector_string_t_assign", _wrap_vector_string_t_assign, METH_VARARGS, "vector_string_t_assign(vector_string_t self, std::vector< std::string >::size_type n, std::vector< std::string >::value_type const & x)"},
-	 { "vector_string_t_resize", _wrap_vector_string_t_resize, METH_VARARGS, "\n"
-		"vector_string_t_resize(vector_string_t self, std::vector< std::string >::size_type new_size)\n"
-		"vector_string_t_resize(vector_string_t self, std::vector< std::string >::size_type new_size, std::vector< std::string >::value_type const & x)\n"
+	 { "vector_string_T_push_back", _wrap_vector_string_T_push_back, METH_VARARGS, "vector_string_T_push_back(vector_string_T self, std::vector< std::string >::value_type const & x)"},
+	 { "vector_string_T_front", _wrap_vector_string_T_front, METH_O, "vector_string_T_front(vector_string_T self) -> std::vector< std::string >::value_type const &"},
+	 { "vector_string_T_back", _wrap_vector_string_T_back, METH_O, "vector_string_T_back(vector_string_T self) -> std::vector< std::string >::value_type const &"},
+	 { "vector_string_T_assign", _wrap_vector_string_T_assign, METH_VARARGS, "vector_string_T_assign(vector_string_T self, std::vector< std::string >::size_type n, std::vector< std::string >::value_type const & x)"},
+	 { "vector_string_T_resize", _wrap_vector_string_T_resize, METH_VARARGS, "\n"
+		"vector_string_T_resize(vector_string_T self, std::vector< std::string >::size_type new_size)\n"
+		"vector_string_T_resize(vector_string_T self, std::vector< std::string >::size_type new_size, std::vector< std::string >::value_type const & x)\n"
 		""},
-	 { "vector_string_t_insert", _wrap_vector_string_t_insert, METH_VARARGS, "\n"
-		"vector_string_t_insert(vector_string_t self, std::vector< std::string >::iterator pos, std::vector< std::string >::value_type const & x) -> std::vector< std::string >::iterator\n"
-		"vector_string_t_insert(vector_string_t self, std::vector< std::string >::iterator pos, std::vector< std::string >::size_type n, std::vector< std::string >::value_type const & x)\n"
+	 { "vector_string_T_insert", _wrap_vector_string_T_insert, METH_VARARGS, "\n"
+		"vector_string_T_insert(vector_string_T self, std::vector< std::string >::iterator pos, std::vector< std::string >::value_type const & x) -> std::vector< std::string >::iterator\n"
+		"vector_string_T_insert(vector_string_T self, std::vector< std::string >::iterator pos, std::vector< std::string >::size_type n, std::vector< std::string >::value_type const & x)\n"
 		""},
-	 { "vector_string_t_reserve", _wrap_vector_string_t_reserve, METH_VARARGS, "vector_string_t_reserve(vector_string_t self, std::vector< std::string >::size_type n)"},
-	 { "vector_string_t_capacity", _wrap_vector_string_t_capacity, METH_O, "vector_string_t_capacity(vector_string_t self) -> std::vector< std::string >::size_type"},
-	 { "delete_vector_string_t", _wrap_delete_vector_string_t, METH_O, "delete_vector_string_t(vector_string_t self)"},
-	 { "vector_string_t_swigregister", vector_string_t_swigregister, METH_O, NULL},
-	 { "vector_string_t_swiginit", vector_string_t_swiginit, METH_VARARGS, NULL},
-	 { "map_string_double_t_iterator", _wrap_map_string_double_t_iterator, METH_O, "map_string_double_t_iterator(map_string_double_t self) -> SwigPyIterator"},
-	 { "map_string_double_t___nonzero__", _wrap_map_string_double_t___nonzero__, METH_O, "map_string_double_t___nonzero__(map_string_double_t self) -> bool"},
-	 { "map_string_double_t___bool__", _wrap_map_string_double_t___bool__, METH_O, "map_string_double_t___bool__(map_string_double_t self) -> bool"},
-	 { "map_string_double_t___len__", _wrap_map_string_double_t___len__, METH_O, "map_string_double_t___len__(map_string_double_t self) -> std::map< std::string,double >::size_type"},
-	 { "map_string_double_t___getitem__", _wrap_map_string_double_t___getitem__, METH_VARARGS, "map_string_double_t___getitem__(map_string_double_t self, std::map< std::string,double >::key_type const & key) -> std::map< std::string,double >::mapped_type const &"},
-	 { "map_string_double_t___delitem__", _wrap_map_string_double_t___delitem__, METH_VARARGS, "map_string_double_t___delitem__(map_string_double_t self, std::map< std::string,double >::key_type const & key)"},
-	 { "map_string_double_t_has_key", _wrap_map_string_double_t_has_key, METH_VARARGS, "map_string_double_t_has_key(map_string_double_t self, std::map< std::string,double >::key_type const & key) -> bool"},
-	 { "map_string_double_t_keys", _wrap_map_string_double_t_keys, METH_O, "map_string_double_t_keys(map_string_double_t self) -> PyObject *"},
-	 { "map_string_double_t_values", _wrap_map_string_double_t_values, METH_O, "map_string_double_t_values(map_string_double_t self) -> PyObject *"},
-	 { "map_string_double_t_items", _wrap_map_string_double_t_items, METH_O, "map_string_double_t_items(map_string_double_t self) -> PyObject *"},
-	 { "map_string_double_t___contains__", _wrap_map_string_double_t___contains__, METH_VARARGS, "map_string_double_t___contains__(map_string_double_t self, std::map< std::string,double >::key_type const & key) -> bool"},
-	 { "map_string_double_t_key_iterator", _wrap_map_string_double_t_key_iterator, METH_O, "map_string_double_t_key_iterator(map_string_double_t self) -> SwigPyIterator"},
-	 { "map_string_double_t_value_iterator", _wrap_map_string_double_t_value_iterator, METH_O, "map_string_double_t_value_iterator(map_string_double_t self) -> SwigPyIterator"},
-	 { "map_string_double_t___setitem__", _wrap_map_string_double_t___setitem__, METH_VARARGS, "\n"
-		"map_string_double_t___setitem__(map_string_double_t self, std::map< std::string,double >::key_type const & key)\n"
-		"map_string_double_t___setitem__(map_string_double_t self, std::map< std::string,double >::key_type const & key, std::map< std::string,double >::mapped_type const & x)\n"
+	 { "vector_string_T_reserve", _wrap_vector_string_T_reserve, METH_VARARGS, "vector_string_T_reserve(vector_string_T self, std::vector< std::string >::size_type n)"},
+	 { "vector_string_T_capacity", _wrap_vector_string_T_capacity, METH_O, "vector_string_T_capacity(vector_string_T self) -> std::vector< std::string >::size_type"},
+	 { "delete_vector_string_T", _wrap_delete_vector_string_T, METH_O, "delete_vector_string_T(vector_string_T self)"},
+	 { "vector_string_T_swigregister", vector_string_T_swigregister, METH_O, NULL},
+	 { "vector_string_T_swiginit", vector_string_T_swiginit, METH_VARARGS, NULL},
+	 { "map_string_double_T_iterator", _wrap_map_string_double_T_iterator, METH_O, "map_string_double_T_iterator(map_string_double_T self) -> SwigPyIterator"},
+	 { "map_string_double_T___nonzero__", _wrap_map_string_double_T___nonzero__, METH_O, "map_string_double_T___nonzero__(map_string_double_T self) -> bool"},
+	 { "map_string_double_T___bool__", _wrap_map_string_double_T___bool__, METH_O, "map_string_double_T___bool__(map_string_double_T self) -> bool"},
+	 { "map_string_double_T___len__", _wrap_map_string_double_T___len__, METH_O, "map_string_double_T___len__(map_string_double_T self) -> std::map< std::string,double >::size_type"},
+	 { "map_string_double_T___getitem__", _wrap_map_string_double_T___getitem__, METH_VARARGS, "map_string_double_T___getitem__(map_string_double_T self, std::map< std::string,double >::key_type const & key) -> std::map< std::string,double >::mapped_type const &"},
+	 { "map_string_double_T___delitem__", _wrap_map_string_double_T___delitem__, METH_VARARGS, "map_string_double_T___delitem__(map_string_double_T self, std::map< std::string,double >::key_type const & key)"},
+	 { "map_string_double_T_has_key", _wrap_map_string_double_T_has_key, METH_VARARGS, "map_string_double_T_has_key(map_string_double_T self, std::map< std::string,double >::key_type const & key) -> bool"},
+	 { "map_string_double_T_keys", _wrap_map_string_double_T_keys, METH_O, "map_string_double_T_keys(map_string_double_T self) -> PyObject *"},
+	 { "map_string_double_T_values", _wrap_map_string_double_T_values, METH_O, "map_string_double_T_values(map_string_double_T self) -> PyObject *"},
+	 { "map_string_double_T_items", _wrap_map_string_double_T_items, METH_O, "map_string_double_T_items(map_string_double_T self) -> PyObject *"},
+	 { "map_string_double_T___contains__", _wrap_map_string_double_T___contains__, METH_VARARGS, "map_string_double_T___contains__(map_string_double_T self, std::map< std::string,double >::key_type const & key) -> bool"},
+	 { "map_string_double_T_key_iterator", _wrap_map_string_double_T_key_iterator, METH_O, "map_string_double_T_key_iterator(map_string_double_T self) -> SwigPyIterator"},
+	 { "map_string_double_T_value_iterator", _wrap_map_string_double_T_value_iterator, METH_O, "map_string_double_T_value_iterator(map_string_double_T self) -> SwigPyIterator"},
+	 { "map_string_double_T___setitem__", _wrap_map_string_double_T___setitem__, METH_VARARGS, "\n"
+		"map_string_double_T___setitem__(map_string_double_T self, std::map< std::string,double >::key_type const & key)\n"
+		"map_string_double_T___setitem__(map_string_double_T self, std::map< std::string,double >::key_type const & key, std::map< std::string,double >::mapped_type const & x)\n"
 		""},
-	 { "map_string_double_t_asdict", _wrap_map_string_double_t_asdict, METH_O, "map_string_double_t_asdict(map_string_double_t self) -> PyObject *"},
-	 { "new_map_string_double_t", _wrap_new_map_string_double_t, METH_VARARGS, "\n"
-		"map_string_double_t(std::less< std::string > const & other)\n"
-		"map_string_double_t()\n"
-		"new_map_string_double_t(map_string_double_t other) -> map_string_double_t\n"
+	 { "map_string_double_T_asdict", _wrap_map_string_double_T_asdict, METH_O, "map_string_double_T_asdict(map_string_double_T self) -> PyObject *"},
+	 { "new_map_string_double_T", _wrap_new_map_string_double_T, METH_VARARGS, "\n"
+		"map_string_double_T(std::less< std::string > const & other)\n"
+		"map_string_double_T()\n"
+		"new_map_string_double_T(map_string_double_T other) -> map_string_double_T\n"
 		""},
-	 { "map_string_double_t_empty", _wrap_map_string_double_t_empty, METH_O, "map_string_double_t_empty(map_string_double_t self) -> bool"},
-	 { "map_string_double_t_size", _wrap_map_string_double_t_size, METH_O, "map_string_double_t_size(map_string_double_t self) -> std::map< std::string,double >::size_type"},
-	 { "map_string_double_t_swap", _wrap_map_string_double_t_swap, METH_VARARGS, "map_string_double_t_swap(map_string_double_t self, map_string_double_t v)"},
-	 { "map_string_double_t_begin", _wrap_map_string_double_t_begin, METH_O, "map_string_double_t_begin(map_string_double_t self) -> std::map< std::string,double >::iterator"},
-	 { "map_string_double_t_end", _wrap_map_string_double_t_end, METH_O, "map_string_double_t_end(map_string_double_t self) -> std::map< std::string,double >::iterator"},
-	 { "map_string_double_t_rbegin", _wrap_map_string_double_t_rbegin, METH_O, "map_string_double_t_rbegin(map_string_double_t self) -> std::map< std::string,double >::reverse_iterator"},
-	 { "map_string_double_t_rend", _wrap_map_string_double_t_rend, METH_O, "map_string_double_t_rend(map_string_double_t self) -> std::map< std::string,double >::reverse_iterator"},
-	 { "map_string_double_t_clear", _wrap_map_string_double_t_clear, METH_O, "map_string_double_t_clear(map_string_double_t self)"},
-	 { "map_string_double_t_get_allocator", _wrap_map_string_double_t_get_allocator, METH_O, "map_string_double_t_get_allocator(map_string_double_t self) -> std::map< std::string,double >::allocator_type"},
-	 { "map_string_double_t_count", _wrap_map_string_double_t_count, METH_VARARGS, "map_string_double_t_count(map_string_double_t self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::size_type"},
-	 { "map_string_double_t_erase", _wrap_map_string_double_t_erase, METH_VARARGS, "\n"
-		"map_string_double_t_erase(map_string_double_t self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::size_type\n"
-		"map_string_double_t_erase(map_string_double_t self, std::map< std::string,double >::iterator position)\n"
-		"map_string_double_t_erase(map_string_double_t self, std::map< std::string,double >::iterator first, std::map< std::string,double >::iterator last)\n"
+	 { "map_string_double_T_empty", _wrap_map_string_double_T_empty, METH_O, "map_string_double_T_empty(map_string_double_T self) -> bool"},
+	 { "map_string_double_T_size", _wrap_map_string_double_T_size, METH_O, "map_string_double_T_size(map_string_double_T self) -> std::map< std::string,double >::size_type"},
+	 { "map_string_double_T_swap", _wrap_map_string_double_T_swap, METH_VARARGS, "map_string_double_T_swap(map_string_double_T self, map_string_double_T v)"},
+	 { "map_string_double_T_begin", _wrap_map_string_double_T_begin, METH_O, "map_string_double_T_begin(map_string_double_T self) -> std::map< std::string,double >::iterator"},
+	 { "map_string_double_T_end", _wrap_map_string_double_T_end, METH_O, "map_string_double_T_end(map_string_double_T self) -> std::map< std::string,double >::iterator"},
+	 { "map_string_double_T_rbegin", _wrap_map_string_double_T_rbegin, METH_O, "map_string_double_T_rbegin(map_string_double_T self) -> std::map< std::string,double >::reverse_iterator"},
+	 { "map_string_double_T_rend", _wrap_map_string_double_T_rend, METH_O, "map_string_double_T_rend(map_string_double_T self) -> std::map< std::string,double >::reverse_iterator"},
+	 { "map_string_double_T_clear", _wrap_map_string_double_T_clear, METH_O, "map_string_double_T_clear(map_string_double_T self)"},
+	 { "map_string_double_T_get_allocator", _wrap_map_string_double_T_get_allocator, METH_O, "map_string_double_T_get_allocator(map_string_double_T self) -> std::map< std::string,double >::allocator_type"},
+	 { "map_string_double_T_count", _wrap_map_string_double_T_count, METH_VARARGS, "map_string_double_T_count(map_string_double_T self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::size_type"},
+	 { "map_string_double_T_erase", _wrap_map_string_double_T_erase, METH_VARARGS, "\n"
+		"map_string_double_T_erase(map_string_double_T self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::size_type\n"
+		"map_string_double_T_erase(map_string_double_T self, std::map< std::string,double >::iterator position)\n"
+		"map_string_double_T_erase(map_string_double_T self, std::map< std::string,double >::iterator first, std::map< std::string,double >::iterator last)\n"
 		""},
-	 { "map_string_double_t_find", _wrap_map_string_double_t_find, METH_VARARGS, "map_string_double_t_find(map_string_double_t self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"},
-	 { "map_string_double_t_lower_bound", _wrap_map_string_double_t_lower_bound, METH_VARARGS, "map_string_double_t_lower_bound(map_string_double_t self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"},
-	 { "map_string_double_t_upper_bound", _wrap_map_string_double_t_upper_bound, METH_VARARGS, "map_string_double_t_upper_bound(map_string_double_t self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"},
-	 { "delete_map_string_double_t", _wrap_delete_map_string_double_t, METH_O, "delete_map_string_double_t(map_string_double_t self)"},
-	 { "map_string_double_t_swigregister", map_string_double_t_swigregister, METH_O, NULL},
-	 { "map_string_double_t_swiginit", map_string_double_t_swiginit, METH_VARARGS, NULL},
-	 { "new_pvacuum_double_t", _wrap_new_pvacuum_double_t, METH_VARARGS, "\n"
-		"pvacuum_double_t()\n"
-		"pvacuum_double_t(double first, double second)\n"
-		"new_pvacuum_double_t(pvacuum_double_t other) -> pvacuum_double_t\n"
+	 { "map_string_double_T_find", _wrap_map_string_double_T_find, METH_VARARGS, "map_string_double_T_find(map_string_double_T self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"},
+	 { "map_string_double_T_lower_bound", _wrap_map_string_double_T_lower_bound, METH_VARARGS, "map_string_double_T_lower_bound(map_string_double_T self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"},
+	 { "map_string_double_T_upper_bound", _wrap_map_string_double_T_upper_bound, METH_VARARGS, "map_string_double_T_upper_bound(map_string_double_T self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"},
+	 { "delete_map_string_double_T", _wrap_delete_map_string_double_T, METH_O, "delete_map_string_double_T(map_string_double_T self)"},
+	 { "map_string_double_T_swigregister", map_string_double_T_swigregister, METH_O, NULL},
+	 { "map_string_double_T_swiginit", map_string_double_T_swiginit, METH_VARARGS, NULL},
+	 { "new_pvacuum_double_T", _wrap_new_pvacuum_double_T, METH_VARARGS, "\n"
+		"pvacuum_double_T()\n"
+		"pvacuum_double_T(double first, double second)\n"
+		"new_pvacuum_double_T(pvacuum_double_T other) -> pvacuum_double_T\n"
 		""},
-	 { "pvacuum_double_t_first_set", _wrap_pvacuum_double_t_first_set, METH_VARARGS, "pvacuum_double_t_first_set(pvacuum_double_t self, double first)"},
-	 { "pvacuum_double_t_first_get", _wrap_pvacuum_double_t_first_get, METH_O, "pvacuum_double_t_first_get(pvacuum_double_t self) -> double"},
-	 { "pvacuum_double_t_second_set", _wrap_pvacuum_double_t_second_set, METH_VARARGS, "pvacuum_double_t_second_set(pvacuum_double_t self, double second)"},
-	 { "pvacuum_double_t_second_get", _wrap_pvacuum_double_t_second_get, METH_O, "pvacuum_double_t_second_get(pvacuum_double_t self) -> double"},
-	 { "delete_pvacuum_double_t", _wrap_delete_pvacuum_double_t, METH_O, "delete_pvacuum_double_t(pvacuum_double_t self)"},
-	 { "pvacuum_double_t_swigregister", pvacuum_double_t_swigregister, METH_O, NULL},
-	 { "pvacuum_double_t_swiginit", pvacuum_double_t_swiginit, METH_VARARGS, NULL},
-	 { "vector_pvacuum_double_t_iterator", _wrap_vector_pvacuum_double_t_iterator, METH_O, "vector_pvacuum_double_t_iterator(vector_pvacuum_double_t self) -> SwigPyIterator"},
-	 { "vector_pvacuum_double_t___nonzero__", _wrap_vector_pvacuum_double_t___nonzero__, METH_O, "vector_pvacuum_double_t___nonzero__(vector_pvacuum_double_t self) -> bool"},
-	 { "vector_pvacuum_double_t___bool__", _wrap_vector_pvacuum_double_t___bool__, METH_O, "vector_pvacuum_double_t___bool__(vector_pvacuum_double_t self) -> bool"},
-	 { "vector_pvacuum_double_t___len__", _wrap_vector_pvacuum_double_t___len__, METH_O, "vector_pvacuum_double_t___len__(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::size_type"},
-	 { "vector_pvacuum_double_t___getslice__", _wrap_vector_pvacuum_double_t___getslice__, METH_VARARGS, "vector_pvacuum_double_t___getslice__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j) -> vector_pvacuum_double_t"},
-	 { "vector_pvacuum_double_t___setslice__", _wrap_vector_pvacuum_double_t___setslice__, METH_VARARGS, "\n"
-		"vector_pvacuum_double_t___setslice__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j)\n"
-		"vector_pvacuum_double_t___setslice__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j, vector_pvacuum_double_t v)\n"
+	 { "pvacuum_double_T_first_set", _wrap_pvacuum_double_T_first_set, METH_VARARGS, "pvacuum_double_T_first_set(pvacuum_double_T self, double first)"},
+	 { "pvacuum_double_T_first_get", _wrap_pvacuum_double_T_first_get, METH_O, "pvacuum_double_T_first_get(pvacuum_double_T self) -> double"},
+	 { "pvacuum_double_T_second_set", _wrap_pvacuum_double_T_second_set, METH_VARARGS, "pvacuum_double_T_second_set(pvacuum_double_T self, double second)"},
+	 { "pvacuum_double_T_second_get", _wrap_pvacuum_double_T_second_get, METH_O, "pvacuum_double_T_second_get(pvacuum_double_T self) -> double"},
+	 { "delete_pvacuum_double_T", _wrap_delete_pvacuum_double_T, METH_O, "delete_pvacuum_double_T(pvacuum_double_T self)"},
+	 { "pvacuum_double_T_swigregister", pvacuum_double_T_swigregister, METH_O, NULL},
+	 { "pvacuum_double_T_swiginit", pvacuum_double_T_swiginit, METH_VARARGS, NULL},
+	 { "vector_pvacuum_double_T_iterator", _wrap_vector_pvacuum_double_T_iterator, METH_O, "vector_pvacuum_double_T_iterator(vector_pvacuum_double_T self) -> SwigPyIterator"},
+	 { "vector_pvacuum_double_T___nonzero__", _wrap_vector_pvacuum_double_T___nonzero__, METH_O, "vector_pvacuum_double_T___nonzero__(vector_pvacuum_double_T self) -> bool"},
+	 { "vector_pvacuum_double_T___bool__", _wrap_vector_pvacuum_double_T___bool__, METH_O, "vector_pvacuum_double_T___bool__(vector_pvacuum_double_T self) -> bool"},
+	 { "vector_pvacuum_double_T___len__", _wrap_vector_pvacuum_double_T___len__, METH_O, "vector_pvacuum_double_T___len__(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::size_type"},
+	 { "vector_pvacuum_double_T___getslice__", _wrap_vector_pvacuum_double_T___getslice__, METH_VARARGS, "vector_pvacuum_double_T___getslice__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j) -> vector_pvacuum_double_T"},
+	 { "vector_pvacuum_double_T___setslice__", _wrap_vector_pvacuum_double_T___setslice__, METH_VARARGS, "\n"
+		"vector_pvacuum_double_T___setslice__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j)\n"
+		"vector_pvacuum_double_T___setslice__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j, vector_pvacuum_double_T v)\n"
 		""},
-	 { "vector_pvacuum_double_t___delslice__", _wrap_vector_pvacuum_double_t___delslice__, METH_VARARGS, "vector_pvacuum_double_t___delslice__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j)"},
-	 { "vector_pvacuum_double_t___delitem__", _wrap_vector_pvacuum_double_t___delitem__, METH_VARARGS, "\n"
-		"vector_pvacuum_double_t___delitem__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i)\n"
-		"vector_pvacuum_double_t___delitem__(vector_pvacuum_double_t self, SWIGPY_SLICEOBJECT * slice)\n"
+	 { "vector_pvacuum_double_T___delslice__", _wrap_vector_pvacuum_double_T___delslice__, METH_VARARGS, "vector_pvacuum_double_T___delslice__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j)"},
+	 { "vector_pvacuum_double_T___delitem__", _wrap_vector_pvacuum_double_T___delitem__, METH_VARARGS, "\n"
+		"vector_pvacuum_double_T___delitem__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i)\n"
+		"vector_pvacuum_double_T___delitem__(vector_pvacuum_double_T self, SWIGPY_SLICEOBJECT * slice)\n"
 		""},
-	 { "vector_pvacuum_double_t___getitem__", _wrap_vector_pvacuum_double_t___getitem__, METH_VARARGS, "\n"
-		"vector_pvacuum_double_t___getitem__(vector_pvacuum_double_t self, SWIGPY_SLICEOBJECT * slice) -> vector_pvacuum_double_t\n"
-		"vector_pvacuum_double_t___getitem__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i) -> pvacuum_double_t\n"
+	 { "vector_pvacuum_double_T___getitem__", _wrap_vector_pvacuum_double_T___getitem__, METH_VARARGS, "\n"
+		"vector_pvacuum_double_T___getitem__(vector_pvacuum_double_T self, SWIGPY_SLICEOBJECT * slice) -> vector_pvacuum_double_T\n"
+		"vector_pvacuum_double_T___getitem__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i) -> pvacuum_double_T\n"
 		""},
-	 { "vector_pvacuum_double_t___setitem__", _wrap_vector_pvacuum_double_t___setitem__, METH_VARARGS, "\n"
-		"vector_pvacuum_double_t___setitem__(vector_pvacuum_double_t self, SWIGPY_SLICEOBJECT * slice, vector_pvacuum_double_t v)\n"
-		"vector_pvacuum_double_t___setitem__(vector_pvacuum_double_t self, SWIGPY_SLICEOBJECT * slice)\n"
-		"vector_pvacuum_double_t___setitem__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i, pvacuum_double_t x)\n"
+	 { "vector_pvacuum_double_T___setitem__", _wrap_vector_pvacuum_double_T___setitem__, METH_VARARGS, "\n"
+		"vector_pvacuum_double_T___setitem__(vector_pvacuum_double_T self, SWIGPY_SLICEOBJECT * slice, vector_pvacuum_double_T v)\n"
+		"vector_pvacuum_double_T___setitem__(vector_pvacuum_double_T self, SWIGPY_SLICEOBJECT * slice)\n"
+		"vector_pvacuum_double_T___setitem__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i, pvacuum_double_T x)\n"
 		""},
-	 { "vector_pvacuum_double_t_pop", _wrap_vector_pvacuum_double_t_pop, METH_O, "vector_pvacuum_double_t_pop(vector_pvacuum_double_t self) -> pvacuum_double_t"},
-	 { "vector_pvacuum_double_t_append", _wrap_vector_pvacuum_double_t_append, METH_VARARGS, "vector_pvacuum_double_t_append(vector_pvacuum_double_t self, pvacuum_double_t x)"},
-	 { "vector_pvacuum_double_t_empty", _wrap_vector_pvacuum_double_t_empty, METH_O, "vector_pvacuum_double_t_empty(vector_pvacuum_double_t self) -> bool"},
-	 { "vector_pvacuum_double_t_size", _wrap_vector_pvacuum_double_t_size, METH_O, "vector_pvacuum_double_t_size(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::size_type"},
-	 { "vector_pvacuum_double_t_swap", _wrap_vector_pvacuum_double_t_swap, METH_VARARGS, "vector_pvacuum_double_t_swap(vector_pvacuum_double_t self, vector_pvacuum_double_t v)"},
-	 { "vector_pvacuum_double_t_begin", _wrap_vector_pvacuum_double_t_begin, METH_O, "vector_pvacuum_double_t_begin(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::iterator"},
-	 { "vector_pvacuum_double_t_end", _wrap_vector_pvacuum_double_t_end, METH_O, "vector_pvacuum_double_t_end(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::iterator"},
-	 { "vector_pvacuum_double_t_rbegin", _wrap_vector_pvacuum_double_t_rbegin, METH_O, "vector_pvacuum_double_t_rbegin(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::reverse_iterator"},
-	 { "vector_pvacuum_double_t_rend", _wrap_vector_pvacuum_double_t_rend, METH_O, "vector_pvacuum_double_t_rend(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::reverse_iterator"},
-	 { "vector_pvacuum_double_t_clear", _wrap_vector_pvacuum_double_t_clear, METH_O, "vector_pvacuum_double_t_clear(vector_pvacuum_double_t self)"},
-	 { "vector_pvacuum_double_t_get_allocator", _wrap_vector_pvacuum_double_t_get_allocator, METH_O, "vector_pvacuum_double_t_get_allocator(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::allocator_type"},
-	 { "vector_pvacuum_double_t_pop_back", _wrap_vector_pvacuum_double_t_pop_back, METH_O, "vector_pvacuum_double_t_pop_back(vector_pvacuum_double_t self)"},
-	 { "vector_pvacuum_double_t_erase", _wrap_vector_pvacuum_double_t_erase, METH_VARARGS, "\n"
-		"vector_pvacuum_double_t_erase(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::iterator pos) -> std::vector< std::pair< double,double > >::iterator\n"
-		"vector_pvacuum_double_t_erase(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::iterator first, std::vector< std::pair< double,double > >::iterator last) -> std::vector< std::pair< double,double > >::iterator\n"
+	 { "vector_pvacuum_double_T_pop", _wrap_vector_pvacuum_double_T_pop, METH_O, "vector_pvacuum_double_T_pop(vector_pvacuum_double_T self) -> pvacuum_double_T"},
+	 { "vector_pvacuum_double_T_append", _wrap_vector_pvacuum_double_T_append, METH_VARARGS, "vector_pvacuum_double_T_append(vector_pvacuum_double_T self, pvacuum_double_T x)"},
+	 { "vector_pvacuum_double_T_empty", _wrap_vector_pvacuum_double_T_empty, METH_O, "vector_pvacuum_double_T_empty(vector_pvacuum_double_T self) -> bool"},
+	 { "vector_pvacuum_double_T_size", _wrap_vector_pvacuum_double_T_size, METH_O, "vector_pvacuum_double_T_size(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::size_type"},
+	 { "vector_pvacuum_double_T_swap", _wrap_vector_pvacuum_double_T_swap, METH_VARARGS, "vector_pvacuum_double_T_swap(vector_pvacuum_double_T self, vector_pvacuum_double_T v)"},
+	 { "vector_pvacuum_double_T_begin", _wrap_vector_pvacuum_double_T_begin, METH_O, "vector_pvacuum_double_T_begin(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::iterator"},
+	 { "vector_pvacuum_double_T_end", _wrap_vector_pvacuum_double_T_end, METH_O, "vector_pvacuum_double_T_end(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::iterator"},
+	 { "vector_pvacuum_double_T_rbegin", _wrap_vector_pvacuum_double_T_rbegin, METH_O, "vector_pvacuum_double_T_rbegin(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::reverse_iterator"},
+	 { "vector_pvacuum_double_T_rend", _wrap_vector_pvacuum_double_T_rend, METH_O, "vector_pvacuum_double_T_rend(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::reverse_iterator"},
+	 { "vector_pvacuum_double_T_clear", _wrap_vector_pvacuum_double_T_clear, METH_O, "vector_pvacuum_double_T_clear(vector_pvacuum_double_T self)"},
+	 { "vector_pvacuum_double_T_get_allocator", _wrap_vector_pvacuum_double_T_get_allocator, METH_O, "vector_pvacuum_double_T_get_allocator(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::allocator_type"},
+	 { "vector_pvacuum_double_T_pop_back", _wrap_vector_pvacuum_double_T_pop_back, METH_O, "vector_pvacuum_double_T_pop_back(vector_pvacuum_double_T self)"},
+	 { "vector_pvacuum_double_T_erase", _wrap_vector_pvacuum_double_T_erase, METH_VARARGS, "\n"
+		"vector_pvacuum_double_T_erase(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::iterator pos) -> std::vector< std::pair< double,double > >::iterator\n"
+		"vector_pvacuum_double_T_erase(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::iterator first, std::vector< std::pair< double,double > >::iterator last) -> std::vector< std::pair< double,double > >::iterator\n"
 		""},
-	 { "new_vector_pvacuum_double_t", _wrap_new_vector_pvacuum_double_t, METH_VARARGS, "\n"
-		"vector_pvacuum_double_t()\n"
-		"vector_pvacuum_double_t(vector_pvacuum_double_t other)\n"
-		"vector_pvacuum_double_t(std::vector< std::pair< double,double > >::size_type size)\n"
-		"new_vector_pvacuum_double_t(std::vector< std::pair< double,double > >::size_type size, pvacuum_double_t value) -> vector_pvacuum_double_t\n"
+	 { "new_vector_pvacuum_double_T", _wrap_new_vector_pvacuum_double_T, METH_VARARGS, "\n"
+		"vector_pvacuum_double_T()\n"
+		"vector_pvacuum_double_T(vector_pvacuum_double_T other)\n"
+		"vector_pvacuum_double_T(std::vector< std::pair< double,double > >::size_type size)\n"
+		"new_vector_pvacuum_double_T(std::vector< std::pair< double,double > >::size_type size, pvacuum_double_T value) -> vector_pvacuum_double_T\n"
 		""},
-	 { "vector_pvacuum_double_t_push_back", _wrap_vector_pvacuum_double_t_push_back, METH_VARARGS, "vector_pvacuum_double_t_push_back(vector_pvacuum_double_t self, pvacuum_double_t x)"},
-	 { "vector_pvacuum_double_t_front", _wrap_vector_pvacuum_double_t_front, METH_O, "vector_pvacuum_double_t_front(vector_pvacuum_double_t self) -> pvacuum_double_t"},
-	 { "vector_pvacuum_double_t_back", _wrap_vector_pvacuum_double_t_back, METH_O, "vector_pvacuum_double_t_back(vector_pvacuum_double_t self) -> pvacuum_double_t"},
-	 { "vector_pvacuum_double_t_assign", _wrap_vector_pvacuum_double_t_assign, METH_VARARGS, "vector_pvacuum_double_t_assign(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::size_type n, pvacuum_double_t x)"},
-	 { "vector_pvacuum_double_t_resize", _wrap_vector_pvacuum_double_t_resize, METH_VARARGS, "\n"
-		"vector_pvacuum_double_t_resize(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::size_type new_size)\n"
-		"vector_pvacuum_double_t_resize(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::size_type new_size, pvacuum_double_t x)\n"
+	 { "vector_pvacuum_double_T_push_back", _wrap_vector_pvacuum_double_T_push_back, METH_VARARGS, "vector_pvacuum_double_T_push_back(vector_pvacuum_double_T self, pvacuum_double_T x)"},
+	 { "vector_pvacuum_double_T_front", _wrap_vector_pvacuum_double_T_front, METH_O, "vector_pvacuum_double_T_front(vector_pvacuum_double_T self) -> pvacuum_double_T"},
+	 { "vector_pvacuum_double_T_back", _wrap_vector_pvacuum_double_T_back, METH_O, "vector_pvacuum_double_T_back(vector_pvacuum_double_T self) -> pvacuum_double_T"},
+	 { "vector_pvacuum_double_T_assign", _wrap_vector_pvacuum_double_T_assign, METH_VARARGS, "vector_pvacuum_double_T_assign(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::size_type n, pvacuum_double_T x)"},
+	 { "vector_pvacuum_double_T_resize", _wrap_vector_pvacuum_double_T_resize, METH_VARARGS, "\n"
+		"vector_pvacuum_double_T_resize(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::size_type new_size)\n"
+		"vector_pvacuum_double_T_resize(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::size_type new_size, pvacuum_double_T x)\n"
 		""},
-	 { "vector_pvacuum_double_t_insert", _wrap_vector_pvacuum_double_t_insert, METH_VARARGS, "\n"
-		"vector_pvacuum_double_t_insert(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::iterator pos, pvacuum_double_t x) -> std::vector< std::pair< double,double > >::iterator\n"
-		"vector_pvacuum_double_t_insert(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::iterator pos, std::vector< std::pair< double,double > >::size_type n, pvacuum_double_t x)\n"
+	 { "vector_pvacuum_double_T_insert", _wrap_vector_pvacuum_double_T_insert, METH_VARARGS, "\n"
+		"vector_pvacuum_double_T_insert(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::iterator pos, pvacuum_double_T x) -> std::vector< std::pair< double,double > >::iterator\n"
+		"vector_pvacuum_double_T_insert(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::iterator pos, std::vector< std::pair< double,double > >::size_type n, pvacuum_double_T x)\n"
 		""},
-	 { "vector_pvacuum_double_t_reserve", _wrap_vector_pvacuum_double_t_reserve, METH_VARARGS, "vector_pvacuum_double_t_reserve(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::size_type n)"},
-	 { "vector_pvacuum_double_t_capacity", _wrap_vector_pvacuum_double_t_capacity, METH_O, "vector_pvacuum_double_t_capacity(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::size_type"},
-	 { "delete_vector_pvacuum_double_t", _wrap_delete_vector_pvacuum_double_t, METH_O, "delete_vector_pvacuum_double_t(vector_pvacuum_double_t self)"},
-	 { "vector_pvacuum_double_t_swigregister", vector_pvacuum_double_t_swigregister, METH_O, NULL},
-	 { "vector_pvacuum_double_t_swiginit", vector_pvacuum_double_t_swiginit, METH_VARARGS, NULL},
+	 { "vector_pvacuum_double_T_reserve", _wrap_vector_pvacuum_double_T_reserve, METH_VARARGS, "vector_pvacuum_double_T_reserve(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::size_type n)"},
+	 { "vector_pvacuum_double_T_capacity", _wrap_vector_pvacuum_double_T_capacity, METH_O, "vector_pvacuum_double_T_capacity(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::size_type"},
+	 { "delete_vector_pvacuum_double_T", _wrap_delete_vector_pvacuum_double_T, METH_O, "delete_vector_pvacuum_double_T(vector_pvacuum_double_T self)"},
+	 { "vector_pvacuum_double_T_swigregister", vector_pvacuum_double_T_swigregister, METH_O, NULL},
+	 { "vector_pvacuum_double_T_swiginit", vector_pvacuum_double_T_swiginit, METH_VARARGS, NULL},
 	 { "new_R3", _wrap_new_R3, METH_VARARGS, "\n"
 		"R3(double const x_, double const y_, double const z_)\n"
 		"new_R3() -> R3\n"
@@ -72595,7 +72595,7 @@ static PyMethodDef SwigMethods[] = {
 	 { "MaterialBySLDImpl_swigregister", MaterialBySLDImpl_swigregister, METH_O, NULL},
 	 { "new_ISampleNode", _wrap_new_ISampleNode, METH_VARARGS, "\n"
 		"ISampleNode()\n"
-		"new_ISampleNode(PyObject * _self, vdouble1d_t PValues) -> ISampleNode\n"
+		"new_ISampleNode(PyObject * _self, vdouble1d_T PValues) -> ISampleNode\n"
 		""},
 	 { "ISampleNode_clone", _wrap_ISampleNode_clone, METH_O, "ISampleNode_clone(ISampleNode self) -> ISampleNode"},
 	 { "delete_ISampleNode", _wrap_delete_ISampleNode, METH_O, "delete_ISampleNode(ISampleNode self)"},
@@ -72604,7 +72604,7 @@ static PyMethodDef SwigMethods[] = {
 	 { "ISampleNode_swiginit", ISampleNode_swiginit, METH_VARARGS, NULL},
 	 { "new_IFormfactor", _wrap_new_IFormfactor, METH_VARARGS, "\n"
 		"IFormfactor()\n"
-		"new_IFormfactor(PyObject * _self, vdouble1d_t PValues) -> IFormfactor\n"
+		"new_IFormfactor(PyObject * _self, vdouble1d_T PValues) -> IFormfactor\n"
 		""},
 	 { "delete_IFormfactor", _wrap_delete_IFormfactor, METH_O, "delete_IFormfactor(IFormfactor self)"},
 	 { "IFormfactor_clone", _wrap_IFormfactor_clone, METH_O, "IFormfactor_clone(IFormfactor self) -> IFormfactor"},
@@ -72642,7 +72642,7 @@ static PyMethodDef SwigMethods[] = {
 	 { "IdentityRotation_swigregister", IdentityRotation_swigregister, METH_O, NULL},
 	 { "IdentityRotation_swiginit", IdentityRotation_swiginit, METH_VARARGS, NULL},
 	 { "new_RotationX", _wrap_new_RotationX, METH_VARARGS, "\n"
-		"RotationX(vdouble1d_t P)\n"
+		"RotationX(vdouble1d_T P)\n"
 		"new_RotationX(double angle) -> RotationX\n"
 		""},
 	 { "RotationX_clone", _wrap_RotationX_clone, METH_O, "RotationX_clone(RotationX self) -> RotationX"},
@@ -72655,7 +72655,7 @@ static PyMethodDef SwigMethods[] = {
 	 { "RotationX_swigregister", RotationX_swigregister, METH_O, NULL},
 	 { "RotationX_swiginit", RotationX_swiginit, METH_VARARGS, NULL},
 	 { "new_RotationY", _wrap_new_RotationY, METH_VARARGS, "\n"
-		"RotationY(vdouble1d_t P)\n"
+		"RotationY(vdouble1d_T P)\n"
 		"new_RotationY(double angle) -> RotationY\n"
 		""},
 	 { "RotationY_clone", _wrap_RotationY_clone, METH_O, "RotationY_clone(RotationY self) -> RotationY"},
@@ -72668,7 +72668,7 @@ static PyMethodDef SwigMethods[] = {
 	 { "RotationY_swigregister", RotationY_swigregister, METH_O, NULL},
 	 { "RotationY_swiginit", RotationY_swiginit, METH_VARARGS, NULL},
 	 { "new_RotationZ", _wrap_new_RotationZ, METH_VARARGS, "\n"
-		"RotationZ(vdouble1d_t P)\n"
+		"RotationZ(vdouble1d_T P)\n"
 		"new_RotationZ(double angle) -> RotationZ\n"
 		""},
 	 { "RotationZ_clone", _wrap_RotationZ_clone, METH_O, "RotationZ_clone(RotationZ self) -> RotationZ"},
@@ -72681,7 +72681,7 @@ static PyMethodDef SwigMethods[] = {
 	 { "RotationZ_swigregister", RotationZ_swigregister, METH_O, NULL},
 	 { "RotationZ_swiginit", RotationZ_swiginit, METH_VARARGS, NULL},
 	 { "new_RotationEuler", _wrap_new_RotationEuler, METH_VARARGS, "\n"
-		"RotationEuler(vdouble1d_t P)\n"
+		"RotationEuler(vdouble1d_T P)\n"
 		"new_RotationEuler(double alpha, double beta, double gamma) -> RotationEuler\n"
 		""},
 	 { "RotationEuler_clone", _wrap_RotationEuler_clone, METH_O, "RotationEuler_clone(RotationEuler self) -> RotationEuler"},
@@ -72759,7 +72759,7 @@ static PyMethodDef SwigMethods[] = {
 	 { "delete_IProfile1D", _wrap_delete_IProfile1D, METH_O, "delete_IProfile1D(IProfile1D self)"},
 	 { "IProfile1D_swigregister", IProfile1D_swigregister, METH_O, NULL},
 	 { "new_Profile1DCauchy", _wrap_new_Profile1DCauchy, METH_VARARGS, "\n"
-		"Profile1DCauchy(vdouble1d_t P)\n"
+		"Profile1DCauchy(vdouble1d_T P)\n"
 		"new_Profile1DCauchy(double omega) -> Profile1DCauchy\n"
 		""},
 	 { "Profile1DCauchy_clone", _wrap_Profile1DCauchy_clone, METH_O, "Profile1DCauchy_clone(Profile1DCauchy self) -> Profile1DCauchy"},
@@ -72771,7 +72771,7 @@ static PyMethodDef SwigMethods[] = {
 	 { "Profile1DCauchy_swigregister", Profile1DCauchy_swigregister, METH_O, NULL},
 	 { "Profile1DCauchy_swiginit", Profile1DCauchy_swiginit, METH_VARARGS, NULL},
 	 { "new_Profile1DGauss", _wrap_new_Profile1DGauss, METH_VARARGS, "\n"
-		"Profile1DGauss(vdouble1d_t P)\n"
+		"Profile1DGauss(vdouble1d_T P)\n"
 		"new_Profile1DGauss(double omega) -> Profile1DGauss\n"
 		""},
 	 { "Profile1DGauss_clone", _wrap_Profile1DGauss_clone, METH_O, "Profile1DGauss_clone(Profile1DGauss self) -> Profile1DGauss"},
@@ -72783,7 +72783,7 @@ static PyMethodDef SwigMethods[] = {
 	 { "Profile1DGauss_swigregister", Profile1DGauss_swigregister, METH_O, NULL},
 	 { "Profile1DGauss_swiginit", Profile1DGauss_swiginit, METH_VARARGS, NULL},
 	 { "new_Profile1DGate", _wrap_new_Profile1DGate, METH_VARARGS, "\n"
-		"Profile1DGate(vdouble1d_t P)\n"
+		"Profile1DGate(vdouble1d_T P)\n"
 		"new_Profile1DGate(double omega) -> Profile1DGate\n"
 		""},
 	 { "Profile1DGate_clone", _wrap_Profile1DGate_clone, METH_O, "Profile1DGate_clone(Profile1DGate self) -> Profile1DGate"},
@@ -72795,7 +72795,7 @@ static PyMethodDef SwigMethods[] = {
 	 { "Profile1DGate_swigregister", Profile1DGate_swigregister, METH_O, NULL},
 	 { "Profile1DGate_swiginit", Profile1DGate_swiginit, METH_VARARGS, NULL},
 	 { "new_Profile1DTriangle", _wrap_new_Profile1DTriangle, METH_VARARGS, "\n"
-		"Profile1DTriangle(vdouble1d_t P)\n"
+		"Profile1DTriangle(vdouble1d_T P)\n"
 		"new_Profile1DTriangle(double omega) -> Profile1DTriangle\n"
 		""},
 	 { "Profile1DTriangle_clone", _wrap_Profile1DTriangle_clone, METH_O, "Profile1DTriangle_clone(Profile1DTriangle self) -> Profile1DTriangle"},
@@ -72807,7 +72807,7 @@ static PyMethodDef SwigMethods[] = {
 	 { "Profile1DTriangle_swigregister", Profile1DTriangle_swigregister, METH_O, NULL},
 	 { "Profile1DTriangle_swiginit", Profile1DTriangle_swiginit, METH_VARARGS, NULL},
 	 { "new_Profile1DCosine", _wrap_new_Profile1DCosine, METH_VARARGS, "\n"
-		"Profile1DCosine(vdouble1d_t P)\n"
+		"Profile1DCosine(vdouble1d_T P)\n"
 		"new_Profile1DCosine(double omega) -> Profile1DCosine\n"
 		""},
 	 { "Profile1DCosine_clone", _wrap_Profile1DCosine_clone, METH_O, "Profile1DCosine_clone(Profile1DCosine self) -> Profile1DCosine"},
@@ -72819,7 +72819,7 @@ static PyMethodDef SwigMethods[] = {
 	 { "Profile1DCosine_swigregister", Profile1DCosine_swigregister, METH_O, NULL},
 	 { "Profile1DCosine_swiginit", Profile1DCosine_swiginit, METH_VARARGS, NULL},
 	 { "new_Profile1DVoigt", _wrap_new_Profile1DVoigt, METH_VARARGS, "\n"
-		"Profile1DVoigt(vdouble1d_t P)\n"
+		"Profile1DVoigt(vdouble1d_T P)\n"
 		"new_Profile1DVoigt(double omega, double eta) -> Profile1DVoigt\n"
 		""},
 	 { "Profile1DVoigt_clone", _wrap_Profile1DVoigt_clone, METH_O, "Profile1DVoigt_clone(Profile1DVoigt self) -> Profile1DVoigt"},
@@ -72847,7 +72847,7 @@ static PyMethodDef SwigMethods[] = {
 	 { "delete_IProfile2D", _wrap_delete_IProfile2D, METH_O, "delete_IProfile2D(IProfile2D self)"},
 	 { "IProfile2D_swigregister", IProfile2D_swigregister, METH_O, NULL},
 	 { "new_Profile2DCauchy", _wrap_new_Profile2DCauchy, METH_VARARGS, "\n"
-		"Profile2DCauchy(vdouble1d_t P)\n"
+		"Profile2DCauchy(vdouble1d_T P)\n"
 		"new_Profile2DCauchy(double omega_x, double omega_y, double gamma) -> Profile2DCauchy\n"
 		""},
 	 { "Profile2DCauchy_clone", _wrap_Profile2DCauchy_clone, METH_O, "Profile2DCauchy_clone(Profile2DCauchy self) -> Profile2DCauchy"},
@@ -72858,7 +72858,7 @@ static PyMethodDef SwigMethods[] = {
 	 { "Profile2DCauchy_swigregister", Profile2DCauchy_swigregister, METH_O, NULL},
 	 { "Profile2DCauchy_swiginit", Profile2DCauchy_swiginit, METH_VARARGS, NULL},
 	 { "new_Profile2DGauss", _wrap_new_Profile2DGauss, METH_VARARGS, "\n"
-		"Profile2DGauss(vdouble1d_t P)\n"
+		"Profile2DGauss(vdouble1d_T P)\n"
 		"new_Profile2DGauss(double omega_x, double omega_y, double gamma) -> Profile2DGauss\n"
 		""},
 	 { "Profile2DGauss_clone", _wrap_Profile2DGauss_clone, METH_O, "Profile2DGauss_clone(Profile2DGauss self) -> Profile2DGauss"},
@@ -72869,7 +72869,7 @@ static PyMethodDef SwigMethods[] = {
 	 { "Profile2DGauss_swigregister", Profile2DGauss_swigregister, METH_O, NULL},
 	 { "Profile2DGauss_swiginit", Profile2DGauss_swiginit, METH_VARARGS, NULL},
 	 { "new_Profile2DGate", _wrap_new_Profile2DGate, METH_VARARGS, "\n"
-		"Profile2DGate(vdouble1d_t P)\n"
+		"Profile2DGate(vdouble1d_T P)\n"
 		"new_Profile2DGate(double omega_x, double omega_y, double gamma) -> Profile2DGate\n"
 		""},
 	 { "Profile2DGate_clone", _wrap_Profile2DGate_clone, METH_O, "Profile2DGate_clone(Profile2DGate self) -> Profile2DGate"},
@@ -72880,7 +72880,7 @@ static PyMethodDef SwigMethods[] = {
 	 { "Profile2DGate_swigregister", Profile2DGate_swigregister, METH_O, NULL},
 	 { "Profile2DGate_swiginit", Profile2DGate_swiginit, METH_VARARGS, NULL},
 	 { "new_Profile2DCone", _wrap_new_Profile2DCone, METH_VARARGS, "\n"
-		"Profile2DCone(vdouble1d_t P)\n"
+		"Profile2DCone(vdouble1d_T P)\n"
 		"new_Profile2DCone(double omega_x, double omega_y, double gamma) -> Profile2DCone\n"
 		""},
 	 { "Profile2DCone_clone", _wrap_Profile2DCone_clone, METH_O, "Profile2DCone_clone(Profile2DCone self) -> Profile2DCone"},
@@ -72891,7 +72891,7 @@ static PyMethodDef SwigMethods[] = {
 	 { "Profile2DCone_swigregister", Profile2DCone_swigregister, METH_O, NULL},
 	 { "Profile2DCone_swiginit", Profile2DCone_swiginit, METH_VARARGS, NULL},
 	 { "new_Profile2DVoigt", _wrap_new_Profile2DVoigt, METH_VARARGS, "\n"
-		"Profile2DVoigt(vdouble1d_t P)\n"
+		"Profile2DVoigt(vdouble1d_T P)\n"
 		"new_Profile2DVoigt(double omega_x, double omega_y, double gamma, double eta) -> Profile2DVoigt\n"
 		""},
 	 { "Profile2DVoigt_clone", _wrap_Profile2DVoigt_clone, METH_O, "Profile2DVoigt_clone(Profile2DVoigt self) -> Profile2DVoigt"},
@@ -73002,7 +73002,7 @@ static PyMethodDef SwigMethods[] = {
 	 { "Interference2DParacrystal_setDomainSizes", _wrap_Interference2DParacrystal_setDomainSizes, METH_VARARGS, "Interference2DParacrystal_setDomainSizes(Interference2DParacrystal self, double size_1, double size_2)"},
 	 { "Interference2DParacrystal_setProbabilityDistributions", _wrap_Interference2DParacrystal_setProbabilityDistributions, METH_VARARGS, "Interference2DParacrystal_setProbabilityDistributions(Interference2DParacrystal self, IProfile2D pdf_1, IProfile2D pdf_2)"},
 	 { "Interference2DParacrystal_setDampingLength", _wrap_Interference2DParacrystal_setDampingLength, METH_VARARGS, "Interference2DParacrystal_setDampingLength(Interference2DParacrystal self, double damping_length)"},
-	 { "Interference2DParacrystal_domainSizes", _wrap_Interference2DParacrystal_domainSizes, METH_O, "Interference2DParacrystal_domainSizes(Interference2DParacrystal self) -> vdouble1d_t"},
+	 { "Interference2DParacrystal_domainSizes", _wrap_Interference2DParacrystal_domainSizes, METH_O, "Interference2DParacrystal_domainSizes(Interference2DParacrystal self) -> vdouble1d_T"},
 	 { "Interference2DParacrystal_setIntegrationOverXi", _wrap_Interference2DParacrystal_setIntegrationOverXi, METH_VARARGS, "Interference2DParacrystal_setIntegrationOverXi(Interference2DParacrystal self, bool integrate_xi)"},
 	 { "Interference2DParacrystal_integrationOverXi", _wrap_Interference2DParacrystal_integrationOverXi, METH_O, "Interference2DParacrystal_integrationOverXi(Interference2DParacrystal self) -> bool"},
 	 { "Interference2DParacrystal_dampingLength", _wrap_Interference2DParacrystal_dampingLength, METH_O, "Interference2DParacrystal_dampingLength(Interference2DParacrystal self) -> double"},
@@ -73190,7 +73190,7 @@ static PyMethodDef SwigMethods[] = {
 	 { "ISawtoothRipple_swigregister", ISawtoothRipple_swigregister, METH_O, NULL},
 	 { "new_Box", _wrap_new_Box, METH_VARARGS, "\n"
 		"Box(double length, double width, double height)\n"
-		"new_Box(vdouble1d_t P) -> Box\n"
+		"new_Box(vdouble1d_T P) -> Box\n"
 		""},
 	 { "Box_clone", _wrap_Box_clone, METH_O, "Box_clone(Box self) -> Box"},
 	 { "Box_className", _wrap_Box_className, METH_O, "Box_className(Box self) -> std::string"},
@@ -73204,7 +73204,7 @@ static PyMethodDef SwigMethods[] = {
 	 { "Box_swiginit", Box_swiginit, METH_VARARGS, NULL},
 	 { "new_Prism3", _wrap_new_Prism3, METH_VARARGS, "\n"
 		"Prism3(double base_edge, double height)\n"
-		"new_Prism3(vdouble1d_t P) -> Prism3\n"
+		"new_Prism3(vdouble1d_T P) -> Prism3\n"
 		""},
 	 { "Prism3_clone", _wrap_Prism3_clone, METH_O, "Prism3_clone(Prism3 self) -> Prism3"},
 	 { "Prism3_className", _wrap_Prism3_className, METH_O, "Prism3_className(Prism3 self) -> std::string"},
@@ -73217,7 +73217,7 @@ static PyMethodDef SwigMethods[] = {
 	 { "Prism3_swiginit", Prism3_swiginit, METH_VARARGS, NULL},
 	 { "new_Prism6", _wrap_new_Prism6, METH_VARARGS, "\n"
 		"Prism6(double base_edge, double height)\n"
-		"new_Prism6(vdouble1d_t P) -> Prism6\n"
+		"new_Prism6(vdouble1d_T P) -> Prism6\n"
 		""},
 	 { "Prism6_clone", _wrap_Prism6_clone, METH_O, "Prism6_clone(Prism6 self) -> Prism6"},
 	 { "Prism6_className", _wrap_Prism6_className, METH_O, "Prism6_className(Prism6 self) -> std::string"},
@@ -73230,7 +73230,7 @@ static PyMethodDef SwigMethods[] = {
 	 { "Prism6_swiginit", Prism6_swiginit, METH_VARARGS, NULL},
 	 { "new_PlatonicTetrahedron", _wrap_new_PlatonicTetrahedron, METH_VARARGS, "\n"
 		"PlatonicTetrahedron(double edge)\n"
-		"new_PlatonicTetrahedron(vdouble1d_t P) -> PlatonicTetrahedron\n"
+		"new_PlatonicTetrahedron(vdouble1d_T P) -> PlatonicTetrahedron\n"
 		""},
 	 { "PlatonicTetrahedron_clone", _wrap_PlatonicTetrahedron_clone, METH_O, "PlatonicTetrahedron_clone(PlatonicTetrahedron self) -> PlatonicTetrahedron"},
 	 { "PlatonicTetrahedron_className", _wrap_PlatonicTetrahedron_className, METH_O, "PlatonicTetrahedron_className(PlatonicTetrahedron self) -> std::string"},
@@ -73243,7 +73243,7 @@ static PyMethodDef SwigMethods[] = {
 	 { "PlatonicTetrahedron_swiginit", PlatonicTetrahedron_swiginit, METH_VARARGS, NULL},
 	 { "new_PlatonicOctahedron", _wrap_new_PlatonicOctahedron, METH_VARARGS, "\n"
 		"PlatonicOctahedron(double edge)\n"
-		"new_PlatonicOctahedron(vdouble1d_t P) -> PlatonicOctahedron\n"
+		"new_PlatonicOctahedron(vdouble1d_T P) -> PlatonicOctahedron\n"
 		""},
 	 { "PlatonicOctahedron_clone", _wrap_PlatonicOctahedron_clone, METH_O, "PlatonicOctahedron_clone(PlatonicOctahedron self) -> PlatonicOctahedron"},
 	 { "PlatonicOctahedron_className", _wrap_PlatonicOctahedron_className, METH_O, "PlatonicOctahedron_className(PlatonicOctahedron self) -> std::string"},
@@ -73256,7 +73256,7 @@ static PyMethodDef SwigMethods[] = {
 	 { "PlatonicOctahedron_swiginit", PlatonicOctahedron_swiginit, METH_VARARGS, NULL},
 	 { "new_Dodecahedron", _wrap_new_Dodecahedron, METH_VARARGS, "\n"
 		"Dodecahedron(double edge)\n"
-		"new_Dodecahedron(vdouble1d_t P) -> Dodecahedron\n"
+		"new_Dodecahedron(vdouble1d_T P) -> Dodecahedron\n"
 		""},
 	 { "Dodecahedron_clone", _wrap_Dodecahedron_clone, METH_O, "Dodecahedron_clone(Dodecahedron self) -> Dodecahedron"},
 	 { "Dodecahedron_className", _wrap_Dodecahedron_className, METH_O, "Dodecahedron_className(Dodecahedron self) -> std::string"},
@@ -73268,7 +73268,7 @@ static PyMethodDef SwigMethods[] = {
 	 { "Dodecahedron_swiginit", Dodecahedron_swiginit, METH_VARARGS, NULL},
 	 { "new_Icosahedron", _wrap_new_Icosahedron, METH_VARARGS, "\n"
 		"Icosahedron(double edge)\n"
-		"new_Icosahedron(vdouble1d_t P) -> Icosahedron\n"
+		"new_Icosahedron(vdouble1d_T P) -> Icosahedron\n"
 		""},
 	 { "Icosahedron_clone", _wrap_Icosahedron_clone, METH_O, "Icosahedron_clone(Icosahedron self) -> Icosahedron"},
 	 { "Icosahedron_className", _wrap_Icosahedron_className, METH_O, "Icosahedron_className(Icosahedron self) -> std::string"},
@@ -73280,7 +73280,7 @@ static PyMethodDef SwigMethods[] = {
 	 { "Icosahedron_swiginit", Icosahedron_swiginit, METH_VARARGS, NULL},
 	 { "new_Pyramid2", _wrap_new_Pyramid2, METH_VARARGS, "\n"
 		"Pyramid2(double length, double width, double height, double alpha)\n"
-		"new_Pyramid2(vdouble1d_t P) -> Pyramid2\n"
+		"new_Pyramid2(vdouble1d_T P) -> Pyramid2\n"
 		""},
 	 { "Pyramid2_clone", _wrap_Pyramid2_clone, METH_O, "Pyramid2_clone(Pyramid2 self) -> Pyramid2"},
 	 { "Pyramid2_className", _wrap_Pyramid2_className, METH_O, "Pyramid2_className(Pyramid2 self) -> std::string"},
@@ -73295,7 +73295,7 @@ static PyMethodDef SwigMethods[] = {
 	 { "Pyramid2_swiginit", Pyramid2_swiginit, METH_VARARGS, NULL},
 	 { "new_Pyramid3", _wrap_new_Pyramid3, METH_VARARGS, "\n"
 		"Pyramid3(double base_edge, double height, double alpha)\n"
-		"new_Pyramid3(vdouble1d_t P) -> Pyramid3\n"
+		"new_Pyramid3(vdouble1d_T P) -> Pyramid3\n"
 		""},
 	 { "Pyramid3_clone", _wrap_Pyramid3_clone, METH_O, "Pyramid3_clone(Pyramid3 self) -> Pyramid3"},
 	 { "Pyramid3_className", _wrap_Pyramid3_className, METH_O, "Pyramid3_className(Pyramid3 self) -> std::string"},
@@ -73309,7 +73309,7 @@ static PyMethodDef SwigMethods[] = {
 	 { "Pyramid3_swiginit", Pyramid3_swiginit, METH_VARARGS, NULL},
 	 { "new_Pyramid4", _wrap_new_Pyramid4, METH_VARARGS, "\n"
 		"Pyramid4(double base_edge, double height, double alpha)\n"
-		"new_Pyramid4(vdouble1d_t P) -> Pyramid4\n"
+		"new_Pyramid4(vdouble1d_T P) -> Pyramid4\n"
 		""},
 	 { "Pyramid4_clone", _wrap_Pyramid4_clone, METH_O, "Pyramid4_clone(Pyramid4 self) -> Pyramid4"},
 	 { "Pyramid4_className", _wrap_Pyramid4_className, METH_O, "Pyramid4_className(Pyramid4 self) -> std::string"},
@@ -73323,7 +73323,7 @@ static PyMethodDef SwigMethods[] = {
 	 { "Pyramid4_swiginit", Pyramid4_swiginit, METH_VARARGS, NULL},
 	 { "new_Pyramid6", _wrap_new_Pyramid6, METH_VARARGS, "\n"
 		"Pyramid6(double base_edge, double height, double alpha)\n"
-		"new_Pyramid6(vdouble1d_t P) -> Pyramid6\n"
+		"new_Pyramid6(vdouble1d_T P) -> Pyramid6\n"
 		""},
 	 { "Pyramid6_clone", _wrap_Pyramid6_clone, METH_O, "Pyramid6_clone(Pyramid6 self) -> Pyramid6"},
 	 { "Pyramid6_className", _wrap_Pyramid6_className, METH_O, "Pyramid6_className(Pyramid6 self) -> std::string"},
@@ -73337,7 +73337,7 @@ static PyMethodDef SwigMethods[] = {
 	 { "Pyramid6_swiginit", Pyramid6_swiginit, METH_VARARGS, NULL},
 	 { "new_Bipyramid4", _wrap_new_Bipyramid4, METH_VARARGS, "\n"
 		"Bipyramid4(double length, double base_height, double height_ratio, double alpha)\n"
-		"new_Bipyramid4(vdouble1d_t P) -> Bipyramid4\n"
+		"new_Bipyramid4(vdouble1d_T P) -> Bipyramid4\n"
 		""},
 	 { "Bipyramid4_clone", _wrap_Bipyramid4_clone, METH_O, "Bipyramid4_clone(Bipyramid4 self) -> Bipyramid4"},
 	 { "Bipyramid4_className", _wrap_Bipyramid4_className, METH_O, "Bipyramid4_className(Bipyramid4 self) -> std::string"},
@@ -73353,7 +73353,7 @@ static PyMethodDef SwigMethods[] = {
 	 { "Bipyramid4_swiginit", Bipyramid4_swiginit, METH_VARARGS, NULL},
 	 { "new_CantellatedCube", _wrap_new_CantellatedCube, METH_VARARGS, "\n"
 		"CantellatedCube(double length, double removed_length)\n"
-		"new_CantellatedCube(vdouble1d_t P) -> CantellatedCube\n"
+		"new_CantellatedCube(vdouble1d_T P) -> CantellatedCube\n"
 		""},
 	 { "CantellatedCube_clone", _wrap_CantellatedCube_clone, METH_O, "CantellatedCube_clone(CantellatedCube self) -> CantellatedCube"},
 	 { "CantellatedCube_className", _wrap_CantellatedCube_className, METH_O, "CantellatedCube_className(CantellatedCube self) -> std::string"},
@@ -73366,7 +73366,7 @@ static PyMethodDef SwigMethods[] = {
 	 { "CantellatedCube_swiginit", CantellatedCube_swiginit, METH_VARARGS, NULL},
 	 { "new_TruncatedCube", _wrap_new_TruncatedCube, METH_VARARGS, "\n"
 		"TruncatedCube(double length, double removed_length)\n"
-		"new_TruncatedCube(vdouble1d_t P) -> TruncatedCube\n"
+		"new_TruncatedCube(vdouble1d_T P) -> TruncatedCube\n"
 		""},
 	 { "TruncatedCube_clone", _wrap_TruncatedCube_clone, METH_O, "TruncatedCube_clone(TruncatedCube self) -> TruncatedCube"},
 	 { "TruncatedCube_className", _wrap_TruncatedCube_className, METH_O, "TruncatedCube_className(TruncatedCube self) -> std::string"},
@@ -73379,7 +73379,7 @@ static PyMethodDef SwigMethods[] = {
 	 { "TruncatedCube_swiginit", TruncatedCube_swiginit, METH_VARARGS, NULL},
 	 { "new_Cone", _wrap_new_Cone, METH_VARARGS, "\n"
 		"Cone(double radius, double height, double alpha)\n"
-		"new_Cone(vdouble1d_t P) -> Cone\n"
+		"new_Cone(vdouble1d_T P) -> Cone\n"
 		""},
 	 { "Cone_clone", _wrap_Cone_clone, METH_O, "Cone_clone(Cone self) -> Cone"},
 	 { "Cone_className", _wrap_Cone_className, METH_O, "Cone_className(Cone self) -> std::string"},
@@ -73396,7 +73396,7 @@ static PyMethodDef SwigMethods[] = {
 	 { "Cone_swiginit", Cone_swiginit, METH_VARARGS, NULL},
 	 { "new_Cylinder", _wrap_new_Cylinder, METH_VARARGS, "\n"
 		"Cylinder(double radius, double height)\n"
-		"new_Cylinder(vdouble1d_t P) -> Cylinder\n"
+		"new_Cylinder(vdouble1d_T P) -> Cylinder\n"
 		""},
 	 { "Cylinder_clone", _wrap_Cylinder_clone, METH_O, "Cylinder_clone(Cylinder self) -> Cylinder"},
 	 { "Cylinder_className", _wrap_Cylinder_className, METH_O, "Cylinder_className(Cylinder self) -> std::string"},
@@ -73412,7 +73412,7 @@ static PyMethodDef SwigMethods[] = {
 	 { "Cylinder_swiginit", Cylinder_swiginit, METH_VARARGS, NULL},
 	 { "new_EllipsoidalCylinder", _wrap_new_EllipsoidalCylinder, METH_VARARGS, "\n"
 		"EllipsoidalCylinder(double radius_x, double radius_y, double height)\n"
-		"new_EllipsoidalCylinder(vdouble1d_t P) -> EllipsoidalCylinder\n"
+		"new_EllipsoidalCylinder(vdouble1d_T P) -> EllipsoidalCylinder\n"
 		""},
 	 { "EllipsoidalCylinder_clone", _wrap_EllipsoidalCylinder_clone, METH_O, "EllipsoidalCylinder_clone(EllipsoidalCylinder self) -> EllipsoidalCylinder"},
 	 { "EllipsoidalCylinder_className", _wrap_EllipsoidalCylinder_className, METH_O, "EllipsoidalCylinder_className(EllipsoidalCylinder self) -> std::string"},
@@ -73429,7 +73429,7 @@ static PyMethodDef SwigMethods[] = {
 	 { "EllipsoidalCylinder_swiginit", EllipsoidalCylinder_swiginit, METH_VARARGS, NULL},
 	 { "new_HemiEllipsoid", _wrap_new_HemiEllipsoid, METH_VARARGS, "\n"
 		"HemiEllipsoid(double radius_x, double radius_y, double height)\n"
-		"new_HemiEllipsoid(vdouble1d_t P) -> HemiEllipsoid\n"
+		"new_HemiEllipsoid(vdouble1d_T P) -> HemiEllipsoid\n"
 		""},
 	 { "delete_HemiEllipsoid", _wrap_delete_HemiEllipsoid, METH_O, "delete_HemiEllipsoid(HemiEllipsoid self)"},
 	 { "HemiEllipsoid_clone", _wrap_HemiEllipsoid_clone, METH_O, "HemiEllipsoid_clone(HemiEllipsoid self) -> HemiEllipsoid"},
@@ -73447,7 +73447,7 @@ static PyMethodDef SwigMethods[] = {
 	 { "new_HorizontalCylinder", _wrap_new_HorizontalCylinder, METH_VARARGS, "\n"
 		"HorizontalCylinder(double radius, double length, double slice_bottom, double slice_top)\n"
 		"HorizontalCylinder(double radius, double length)\n"
-		"new_HorizontalCylinder(vdouble1d_t P) -> HorizontalCylinder\n"
+		"new_HorizontalCylinder(vdouble1d_T P) -> HorizontalCylinder\n"
 		""},
 	 { "HorizontalCylinder_clone", _wrap_HorizontalCylinder_clone, METH_O, "HorizontalCylinder_clone(HorizontalCylinder self) -> HorizontalCylinder"},
 	 { "HorizontalCylinder_className", _wrap_HorizontalCylinder_className, METH_O, "HorizontalCylinder_className(HorizontalCylinder self) -> std::string"},
@@ -73466,7 +73466,7 @@ static PyMethodDef SwigMethods[] = {
 	 { "HorizontalCylinder_swiginit", HorizontalCylinder_swiginit, METH_VARARGS, NULL},
 	 { "new_Sphere", _wrap_new_Sphere, METH_VARARGS, "\n"
 		"Sphere(double radius, bool position_at_center=False)\n"
-		"Sphere(vdouble1d_t P, bool position_at_center=False)\n"
+		"Sphere(vdouble1d_T P, bool position_at_center=False)\n"
 		""},
 	 { "Sphere_clone", _wrap_Sphere_clone, METH_O, "Sphere_clone(Sphere self) -> Sphere"},
 	 { "Sphere_className", _wrap_Sphere_className, METH_O, "Sphere_className(Sphere self) -> std::string"},
@@ -73483,7 +73483,7 @@ static PyMethodDef SwigMethods[] = {
 	 { "Sphere_swiginit", Sphere_swiginit, METH_VARARGS, NULL},
 	 { "new_Spheroid", _wrap_new_Spheroid, METH_VARARGS, "\n"
 		"Spheroid(double radius, double height)\n"
-		"new_Spheroid(vdouble1d_t P) -> Spheroid\n"
+		"new_Spheroid(vdouble1d_T P) -> Spheroid\n"
 		""},
 	 { "Spheroid_clone", _wrap_Spheroid_clone, METH_O, "Spheroid_clone(Spheroid self) -> Spheroid"},
 	 { "Spheroid_className", _wrap_Spheroid_className, METH_O, "Spheroid_className(Spheroid self) -> std::string"},
@@ -73499,7 +73499,7 @@ static PyMethodDef SwigMethods[] = {
 	 { "Spheroid_swiginit", Spheroid_swiginit, METH_VARARGS, NULL},
 	 { "new_TruncatedSphere", _wrap_new_TruncatedSphere, METH_VARARGS, "\n"
 		"TruncatedSphere(double radius, double untruncated_height, double dh)\n"
-		"new_TruncatedSphere(vdouble1d_t P) -> TruncatedSphere\n"
+		"new_TruncatedSphere(vdouble1d_T P) -> TruncatedSphere\n"
 		""},
 	 { "TruncatedSphere_clone", _wrap_TruncatedSphere_clone, METH_O, "TruncatedSphere_clone(TruncatedSphere self) -> TruncatedSphere"},
 	 { "TruncatedSphere_className", _wrap_TruncatedSphere_className, METH_O, "TruncatedSphere_className(TruncatedSphere self) -> std::string"},
@@ -73517,7 +73517,7 @@ static PyMethodDef SwigMethods[] = {
 	 { "TruncatedSphere_swiginit", TruncatedSphere_swiginit, METH_VARARGS, NULL},
 	 { "new_TruncatedSpheroid", _wrap_new_TruncatedSpheroid, METH_VARARGS, "\n"
 		"TruncatedSpheroid(double radius, double untruncated_height, double untruncated_height_flattening, double dh)\n"
-		"new_TruncatedSpheroid(vdouble1d_t P) -> TruncatedSpheroid\n"
+		"new_TruncatedSpheroid(vdouble1d_T P) -> TruncatedSpheroid\n"
 		""},
 	 { "TruncatedSpheroid_clone", _wrap_TruncatedSpheroid_clone, METH_O, "TruncatedSpheroid_clone(TruncatedSpheroid self) -> TruncatedSpheroid"},
 	 { "TruncatedSpheroid_className", _wrap_TruncatedSpheroid_className, METH_O, "TruncatedSpheroid_className(TruncatedSpheroid self) -> std::string"},
@@ -73536,7 +73536,7 @@ static PyMethodDef SwigMethods[] = {
 	 { "TruncatedSpheroid_swiginit", TruncatedSpheroid_swiginit, METH_VARARGS, NULL},
 	 { "new_BarGauss", _wrap_new_BarGauss, METH_VARARGS, "\n"
 		"BarGauss(double length, double width, double height)\n"
-		"new_BarGauss(vdouble1d_t P) -> BarGauss\n"
+		"new_BarGauss(vdouble1d_T P) -> BarGauss\n"
 		""},
 	 { "BarGauss_clone", _wrap_BarGauss_clone, METH_O, "BarGauss_clone(BarGauss self) -> BarGauss"},
 	 { "BarGauss_className", _wrap_BarGauss_className, METH_O, "BarGauss_className(BarGauss self) -> std::string"},
@@ -73547,7 +73547,7 @@ static PyMethodDef SwigMethods[] = {
 	 { "BarGauss_swiginit", BarGauss_swiginit, METH_VARARGS, NULL},
 	 { "new_BarLorentz", _wrap_new_BarLorentz, METH_VARARGS, "\n"
 		"BarLorentz(double length, double width, double height)\n"
-		"new_BarLorentz(vdouble1d_t P) -> BarLorentz\n"
+		"new_BarLorentz(vdouble1d_T P) -> BarLorentz\n"
 		""},
 	 { "BarLorentz_clone", _wrap_BarLorentz_clone, METH_O, "BarLorentz_clone(BarLorentz self) -> BarLorentz"},
 	 { "BarLorentz_className", _wrap_BarLorentz_className, METH_O, "BarLorentz_className(BarLorentz self) -> std::string"},
@@ -73558,7 +73558,7 @@ static PyMethodDef SwigMethods[] = {
 	 { "BarLorentz_swiginit", BarLorentz_swiginit, METH_VARARGS, NULL},
 	 { "new_CosineRippleBox", _wrap_new_CosineRippleBox, METH_VARARGS, "\n"
 		"CosineRippleBox(double length, double width, double height)\n"
-		"new_CosineRippleBox(vdouble1d_t P) -> CosineRippleBox\n"
+		"new_CosineRippleBox(vdouble1d_T P) -> CosineRippleBox\n"
 		""},
 	 { "CosineRippleBox_clone", _wrap_CosineRippleBox_clone, METH_O, "CosineRippleBox_clone(CosineRippleBox self) -> CosineRippleBox"},
 	 { "CosineRippleBox_className", _wrap_CosineRippleBox_className, METH_O, "CosineRippleBox_className(CosineRippleBox self) -> std::string"},
@@ -73569,7 +73569,7 @@ static PyMethodDef SwigMethods[] = {
 	 { "CosineRippleBox_swiginit", CosineRippleBox_swiginit, METH_VARARGS, NULL},
 	 { "new_CosineRippleGauss", _wrap_new_CosineRippleGauss, METH_VARARGS, "\n"
 		"CosineRippleGauss(double length, double width, double height)\n"
-		"new_CosineRippleGauss(vdouble1d_t P) -> CosineRippleGauss\n"
+		"new_CosineRippleGauss(vdouble1d_T P) -> CosineRippleGauss\n"
 		""},
 	 { "CosineRippleGauss_clone", _wrap_CosineRippleGauss_clone, METH_O, "CosineRippleGauss_clone(CosineRippleGauss self) -> CosineRippleGauss"},
 	 { "CosineRippleGauss_className", _wrap_CosineRippleGauss_className, METH_O, "CosineRippleGauss_className(CosineRippleGauss self) -> std::string"},
@@ -73580,7 +73580,7 @@ static PyMethodDef SwigMethods[] = {
 	 { "CosineRippleGauss_swiginit", CosineRippleGauss_swiginit, METH_VARARGS, NULL},
 	 { "new_CosineRippleLorentz", _wrap_new_CosineRippleLorentz, METH_VARARGS, "\n"
 		"CosineRippleLorentz(double length, double width, double height)\n"
-		"new_CosineRippleLorentz(vdouble1d_t P) -> CosineRippleLorentz\n"
+		"new_CosineRippleLorentz(vdouble1d_T P) -> CosineRippleLorentz\n"
 		""},
 	 { "CosineRippleLorentz_clone", _wrap_CosineRippleLorentz_clone, METH_O, "CosineRippleLorentz_clone(CosineRippleLorentz self) -> CosineRippleLorentz"},
 	 { "CosineRippleLorentz_className", _wrap_CosineRippleLorentz_className, METH_O, "CosineRippleLorentz_className(CosineRippleLorentz self) -> std::string"},
@@ -73591,7 +73591,7 @@ static PyMethodDef SwigMethods[] = {
 	 { "CosineRippleLorentz_swiginit", CosineRippleLorentz_swiginit, METH_VARARGS, NULL},
 	 { "new_SawtoothRippleBox", _wrap_new_SawtoothRippleBox, METH_VARARGS, "\n"
 		"SawtoothRippleBox(double length, double width, double height, double asymmetry)\n"
-		"new_SawtoothRippleBox(vdouble1d_t P) -> SawtoothRippleBox\n"
+		"new_SawtoothRippleBox(vdouble1d_T P) -> SawtoothRippleBox\n"
 		""},
 	 { "SawtoothRippleBox_clone", _wrap_SawtoothRippleBox_clone, METH_O, "SawtoothRippleBox_clone(SawtoothRippleBox self) -> SawtoothRippleBox"},
 	 { "SawtoothRippleBox_className", _wrap_SawtoothRippleBox_className, METH_O, "SawtoothRippleBox_className(SawtoothRippleBox self) -> std::string"},
@@ -73602,7 +73602,7 @@ static PyMethodDef SwigMethods[] = {
 	 { "SawtoothRippleBox_swiginit", SawtoothRippleBox_swiginit, METH_VARARGS, NULL},
 	 { "new_SawtoothRippleGauss", _wrap_new_SawtoothRippleGauss, METH_VARARGS, "\n"
 		"SawtoothRippleGauss(double length, double width, double height, double asymmetry)\n"
-		"new_SawtoothRippleGauss(vdouble1d_t P) -> SawtoothRippleGauss\n"
+		"new_SawtoothRippleGauss(vdouble1d_T P) -> SawtoothRippleGauss\n"
 		""},
 	 { "SawtoothRippleGauss_clone", _wrap_SawtoothRippleGauss_clone, METH_O, "SawtoothRippleGauss_clone(SawtoothRippleGauss self) -> SawtoothRippleGauss"},
 	 { "SawtoothRippleGauss_className", _wrap_SawtoothRippleGauss_className, METH_O, "SawtoothRippleGauss_className(SawtoothRippleGauss self) -> std::string"},
@@ -73613,7 +73613,7 @@ static PyMethodDef SwigMethods[] = {
 	 { "SawtoothRippleGauss_swiginit", SawtoothRippleGauss_swiginit, METH_VARARGS, NULL},
 	 { "new_SawtoothRippleLorentz", _wrap_new_SawtoothRippleLorentz, METH_VARARGS, "\n"
 		"SawtoothRippleLorentz(double length, double width, double height, double asymmetry)\n"
-		"new_SawtoothRippleLorentz(vdouble1d_t P) -> SawtoothRippleLorentz\n"
+		"new_SawtoothRippleLorentz(vdouble1d_T P) -> SawtoothRippleLorentz\n"
 		""},
 	 { "SawtoothRippleLorentz_clone", _wrap_SawtoothRippleLorentz_clone, METH_O, "SawtoothRippleLorentz_clone(SawtoothRippleLorentz self) -> SawtoothRippleLorentz"},
 	 { "SawtoothRippleLorentz_className", _wrap_SawtoothRippleLorentz_className, METH_O, "SawtoothRippleLorentz_className(SawtoothRippleLorentz self) -> std::string"},
@@ -73624,7 +73624,7 @@ static PyMethodDef SwigMethods[] = {
 	 { "SawtoothRippleLorentz_swiginit", SawtoothRippleLorentz_swiginit, METH_VARARGS, NULL},
 	 { "new_LongBoxGauss", _wrap_new_LongBoxGauss, METH_VARARGS, "\n"
 		"LongBoxGauss(double length, double width, double height)\n"
-		"new_LongBoxGauss(vdouble1d_t P) -> LongBoxGauss\n"
+		"new_LongBoxGauss(vdouble1d_T P) -> LongBoxGauss\n"
 		""},
 	 { "LongBoxGauss_clone", _wrap_LongBoxGauss_clone, METH_O, "LongBoxGauss_clone(LongBoxGauss self) -> LongBoxGauss"},
 	 { "LongBoxGauss_className", _wrap_LongBoxGauss_className, METH_O, "LongBoxGauss_className(LongBoxGauss self) -> std::string"},
@@ -73641,7 +73641,7 @@ static PyMethodDef SwigMethods[] = {
 	 { "LongBoxGauss_swiginit", LongBoxGauss_swiginit, METH_VARARGS, NULL},
 	 { "new_LongBoxLorentz", _wrap_new_LongBoxLorentz, METH_VARARGS, "\n"
 		"LongBoxLorentz(double length, double width, double height)\n"
-		"new_LongBoxLorentz(vdouble1d_t P) -> LongBoxLorentz\n"
+		"new_LongBoxLorentz(vdouble1d_T P) -> LongBoxLorentz\n"
 		""},
 	 { "LongBoxLorentz_clone", _wrap_LongBoxLorentz_clone, METH_O, "LongBoxLorentz_clone(LongBoxLorentz self) -> LongBoxLorentz"},
 	 { "LongBoxLorentz_className", _wrap_LongBoxLorentz_className, METH_O, "LongBoxLorentz_className(LongBoxLorentz self) -> std::string"},
@@ -73657,7 +73657,7 @@ static PyMethodDef SwigMethods[] = {
 	 { "LongBoxLorentz_swigregister", LongBoxLorentz_swigregister, METH_O, NULL},
 	 { "LongBoxLorentz_swiginit", LongBoxLorentz_swiginit, METH_VARARGS, NULL},
 	 { "new_GaussSphere", _wrap_new_GaussSphere, METH_VARARGS, "\n"
-		"GaussSphere(vdouble1d_t P)\n"
+		"GaussSphere(vdouble1d_T P)\n"
 		"new_GaussSphere(double mean_radius) -> GaussSphere\n"
 		""},
 	 { "GaussSphere_clone", _wrap_GaussSphere_clone, METH_O, "GaussSphere_clone(GaussSphere self) -> GaussSphere"},
@@ -73672,7 +73672,7 @@ static PyMethodDef SwigMethods[] = {
 	 { "GaussSphere_swigregister", GaussSphere_swigregister, METH_O, NULL},
 	 { "GaussSphere_swiginit", GaussSphere_swiginit, METH_VARARGS, NULL},
 	 { "new_FuzzySphere", _wrap_new_FuzzySphere, METH_VARARGS, "\n"
-		"FuzzySphere(vdouble1d_t P)\n"
+		"FuzzySphere(vdouble1d_T P)\n"
 		"new_FuzzySphere(double mean, double sigma) -> FuzzySphere\n"
 		""},
 	 { "FuzzySphere_clone", _wrap_FuzzySphere_clone, METH_O, "FuzzySphere_clone(FuzzySphere self) -> FuzzySphere"},
diff --git a/auto/Wrap/libBornAgainSim.py b/auto/Wrap/libBornAgainSim.py
index ae9acb7b3c9dcc930875253b546924ff4e9e7871..6aa02d8ad81633abb6ca8a59c0b8ebaa8b961414 100644
--- a/auto/Wrap/libBornAgainSim.py
+++ b/auto/Wrap/libBornAgainSim.py
@@ -153,1191 +153,1191 @@ def deprecated(message):
       return deprecated_func
   return deprecated_decorator
 
-class vdouble1d_t(object):
+class vdouble1d_T(object):
     r"""Proxy of C++ std::vector< double > class."""
 
     thisown = property(lambda x: x.this.own(), lambda x, v: x.this.own(v), doc="The membership flag")
     __repr__ = _swig_repr
 
     def iterator(self):
-        r"""iterator(vdouble1d_t self) -> SwigPyIterator"""
-        return _libBornAgainSim.vdouble1d_t_iterator(self)
+        r"""iterator(vdouble1d_T self) -> SwigPyIterator"""
+        return _libBornAgainSim.vdouble1d_T_iterator(self)
     def __iter__(self):
         return self.iterator()
 
     def __nonzero__(self):
-        r"""__nonzero__(vdouble1d_t self) -> bool"""
-        return _libBornAgainSim.vdouble1d_t___nonzero__(self)
+        r"""__nonzero__(vdouble1d_T self) -> bool"""
+        return _libBornAgainSim.vdouble1d_T___nonzero__(self)
 
     def __bool__(self):
-        r"""__bool__(vdouble1d_t self) -> bool"""
-        return _libBornAgainSim.vdouble1d_t___bool__(self)
+        r"""__bool__(vdouble1d_T self) -> bool"""
+        return _libBornAgainSim.vdouble1d_T___bool__(self)
 
     def __len__(self):
-        r"""__len__(vdouble1d_t self) -> std::vector< double >::size_type"""
-        return _libBornAgainSim.vdouble1d_t___len__(self)
+        r"""__len__(vdouble1d_T self) -> std::vector< double >::size_type"""
+        return _libBornAgainSim.vdouble1d_T___len__(self)
 
     def __getslice__(self, i, j):
-        r"""__getslice__(vdouble1d_t self, std::vector< double >::difference_type i, std::vector< double >::difference_type j) -> vdouble1d_t"""
-        return _libBornAgainSim.vdouble1d_t___getslice__(self, i, j)
+        r"""__getslice__(vdouble1d_T self, std::vector< double >::difference_type i, std::vector< double >::difference_type j) -> vdouble1d_T"""
+        return _libBornAgainSim.vdouble1d_T___getslice__(self, i, j)
 
     def __setslice__(self, *args):
         r"""
-        __setslice__(vdouble1d_t self, std::vector< double >::difference_type i, std::vector< double >::difference_type j)
-        __setslice__(vdouble1d_t self, std::vector< double >::difference_type i, std::vector< double >::difference_type j, vdouble1d_t v)
+        __setslice__(vdouble1d_T self, std::vector< double >::difference_type i, std::vector< double >::difference_type j)
+        __setslice__(vdouble1d_T self, std::vector< double >::difference_type i, std::vector< double >::difference_type j, vdouble1d_T v)
         """
-        return _libBornAgainSim.vdouble1d_t___setslice__(self, *args)
+        return _libBornAgainSim.vdouble1d_T___setslice__(self, *args)
 
     def __delslice__(self, i, j):
-        r"""__delslice__(vdouble1d_t self, std::vector< double >::difference_type i, std::vector< double >::difference_type j)"""
-        return _libBornAgainSim.vdouble1d_t___delslice__(self, i, j)
+        r"""__delslice__(vdouble1d_T self, std::vector< double >::difference_type i, std::vector< double >::difference_type j)"""
+        return _libBornAgainSim.vdouble1d_T___delslice__(self, i, j)
 
     def __delitem__(self, *args):
         r"""
-        __delitem__(vdouble1d_t self, std::vector< double >::difference_type i)
-        __delitem__(vdouble1d_t self, SWIGPY_SLICEOBJECT * slice)
+        __delitem__(vdouble1d_T self, std::vector< double >::difference_type i)
+        __delitem__(vdouble1d_T self, SWIGPY_SLICEOBJECT * slice)
         """
-        return _libBornAgainSim.vdouble1d_t___delitem__(self, *args)
+        return _libBornAgainSim.vdouble1d_T___delitem__(self, *args)
 
     def __getitem__(self, *args):
         r"""
-        __getitem__(vdouble1d_t self, SWIGPY_SLICEOBJECT * slice) -> vdouble1d_t
-        __getitem__(vdouble1d_t self, std::vector< double >::difference_type i) -> std::vector< double >::value_type const &
+        __getitem__(vdouble1d_T self, SWIGPY_SLICEOBJECT * slice) -> vdouble1d_T
+        __getitem__(vdouble1d_T self, std::vector< double >::difference_type i) -> std::vector< double >::value_type const &
         """
-        return _libBornAgainSim.vdouble1d_t___getitem__(self, *args)
+        return _libBornAgainSim.vdouble1d_T___getitem__(self, *args)
 
     def __setitem__(self, *args):
         r"""
-        __setitem__(vdouble1d_t self, SWIGPY_SLICEOBJECT * slice, vdouble1d_t v)
-        __setitem__(vdouble1d_t self, SWIGPY_SLICEOBJECT * slice)
-        __setitem__(vdouble1d_t self, std::vector< double >::difference_type i, std::vector< double >::value_type const & x)
+        __setitem__(vdouble1d_T self, SWIGPY_SLICEOBJECT * slice, vdouble1d_T v)
+        __setitem__(vdouble1d_T self, SWIGPY_SLICEOBJECT * slice)
+        __setitem__(vdouble1d_T self, std::vector< double >::difference_type i, std::vector< double >::value_type const & x)
         """
-        return _libBornAgainSim.vdouble1d_t___setitem__(self, *args)
+        return _libBornAgainSim.vdouble1d_T___setitem__(self, *args)
 
     def pop(self):
-        r"""pop(vdouble1d_t self) -> std::vector< double >::value_type"""
-        return _libBornAgainSim.vdouble1d_t_pop(self)
+        r"""pop(vdouble1d_T self) -> std::vector< double >::value_type"""
+        return _libBornAgainSim.vdouble1d_T_pop(self)
 
     def append(self, x):
-        r"""append(vdouble1d_t self, std::vector< double >::value_type const & x)"""
-        return _libBornAgainSim.vdouble1d_t_append(self, x)
+        r"""append(vdouble1d_T self, std::vector< double >::value_type const & x)"""
+        return _libBornAgainSim.vdouble1d_T_append(self, x)
 
     def empty(self):
-        r"""empty(vdouble1d_t self) -> bool"""
-        return _libBornAgainSim.vdouble1d_t_empty(self)
+        r"""empty(vdouble1d_T self) -> bool"""
+        return _libBornAgainSim.vdouble1d_T_empty(self)
 
     def size(self):
-        r"""size(vdouble1d_t self) -> std::vector< double >::size_type"""
-        return _libBornAgainSim.vdouble1d_t_size(self)
+        r"""size(vdouble1d_T self) -> std::vector< double >::size_type"""
+        return _libBornAgainSim.vdouble1d_T_size(self)
 
     def swap(self, v):
-        r"""swap(vdouble1d_t self, vdouble1d_t v)"""
-        return _libBornAgainSim.vdouble1d_t_swap(self, v)
+        r"""swap(vdouble1d_T self, vdouble1d_T v)"""
+        return _libBornAgainSim.vdouble1d_T_swap(self, v)
 
     def begin(self):
-        r"""begin(vdouble1d_t self) -> std::vector< double >::iterator"""
-        return _libBornAgainSim.vdouble1d_t_begin(self)
+        r"""begin(vdouble1d_T self) -> std::vector< double >::iterator"""
+        return _libBornAgainSim.vdouble1d_T_begin(self)
 
     def end(self):
-        r"""end(vdouble1d_t self) -> std::vector< double >::iterator"""
-        return _libBornAgainSim.vdouble1d_t_end(self)
+        r"""end(vdouble1d_T self) -> std::vector< double >::iterator"""
+        return _libBornAgainSim.vdouble1d_T_end(self)
 
     def rbegin(self):
-        r"""rbegin(vdouble1d_t self) -> std::vector< double >::reverse_iterator"""
-        return _libBornAgainSim.vdouble1d_t_rbegin(self)
+        r"""rbegin(vdouble1d_T self) -> std::vector< double >::reverse_iterator"""
+        return _libBornAgainSim.vdouble1d_T_rbegin(self)
 
     def rend(self):
-        r"""rend(vdouble1d_t self) -> std::vector< double >::reverse_iterator"""
-        return _libBornAgainSim.vdouble1d_t_rend(self)
+        r"""rend(vdouble1d_T self) -> std::vector< double >::reverse_iterator"""
+        return _libBornAgainSim.vdouble1d_T_rend(self)
 
     def clear(self):
-        r"""clear(vdouble1d_t self)"""
-        return _libBornAgainSim.vdouble1d_t_clear(self)
+        r"""clear(vdouble1d_T self)"""
+        return _libBornAgainSim.vdouble1d_T_clear(self)
 
     def get_allocator(self):
-        r"""get_allocator(vdouble1d_t self) -> std::vector< double >::allocator_type"""
-        return _libBornAgainSim.vdouble1d_t_get_allocator(self)
+        r"""get_allocator(vdouble1d_T self) -> std::vector< double >::allocator_type"""
+        return _libBornAgainSim.vdouble1d_T_get_allocator(self)
 
     def pop_back(self):
-        r"""pop_back(vdouble1d_t self)"""
-        return _libBornAgainSim.vdouble1d_t_pop_back(self)
+        r"""pop_back(vdouble1d_T self)"""
+        return _libBornAgainSim.vdouble1d_T_pop_back(self)
 
     def erase(self, *args):
         r"""
-        erase(vdouble1d_t self, std::vector< double >::iterator pos) -> std::vector< double >::iterator
-        erase(vdouble1d_t self, std::vector< double >::iterator first, std::vector< double >::iterator last) -> std::vector< double >::iterator
+        erase(vdouble1d_T self, std::vector< double >::iterator pos) -> std::vector< double >::iterator
+        erase(vdouble1d_T self, std::vector< double >::iterator first, std::vector< double >::iterator last) -> std::vector< double >::iterator
         """
-        return _libBornAgainSim.vdouble1d_t_erase(self, *args)
+        return _libBornAgainSim.vdouble1d_T_erase(self, *args)
 
     def __init__(self, *args):
         r"""
-        __init__(vdouble1d_t self) -> vdouble1d_t
-        __init__(vdouble1d_t self, vdouble1d_t other) -> vdouble1d_t
-        __init__(vdouble1d_t self, std::vector< double >::size_type size) -> vdouble1d_t
-        __init__(vdouble1d_t self, std::vector< double >::size_type size, std::vector< double >::value_type const & value) -> vdouble1d_t
+        __init__(vdouble1d_T self) -> vdouble1d_T
+        __init__(vdouble1d_T self, vdouble1d_T other) -> vdouble1d_T
+        __init__(vdouble1d_T self, std::vector< double >::size_type size) -> vdouble1d_T
+        __init__(vdouble1d_T self, std::vector< double >::size_type size, std::vector< double >::value_type const & value) -> vdouble1d_T
         """
-        _libBornAgainSim.vdouble1d_t_swiginit(self, _libBornAgainSim.new_vdouble1d_t(*args))
+        _libBornAgainSim.vdouble1d_T_swiginit(self, _libBornAgainSim.new_vdouble1d_T(*args))
 
     def push_back(self, x):
-        r"""push_back(vdouble1d_t self, std::vector< double >::value_type const & x)"""
-        return _libBornAgainSim.vdouble1d_t_push_back(self, x)
+        r"""push_back(vdouble1d_T self, std::vector< double >::value_type const & x)"""
+        return _libBornAgainSim.vdouble1d_T_push_back(self, x)
 
     def front(self):
-        r"""front(vdouble1d_t self) -> std::vector< double >::value_type const &"""
-        return _libBornAgainSim.vdouble1d_t_front(self)
+        r"""front(vdouble1d_T self) -> std::vector< double >::value_type const &"""
+        return _libBornAgainSim.vdouble1d_T_front(self)
 
     def back(self):
-        r"""back(vdouble1d_t self) -> std::vector< double >::value_type const &"""
-        return _libBornAgainSim.vdouble1d_t_back(self)
+        r"""back(vdouble1d_T self) -> std::vector< double >::value_type const &"""
+        return _libBornAgainSim.vdouble1d_T_back(self)
 
     def assign(self, n, x):
-        r"""assign(vdouble1d_t self, std::vector< double >::size_type n, std::vector< double >::value_type const & x)"""
-        return _libBornAgainSim.vdouble1d_t_assign(self, n, x)
+        r"""assign(vdouble1d_T self, std::vector< double >::size_type n, std::vector< double >::value_type const & x)"""
+        return _libBornAgainSim.vdouble1d_T_assign(self, n, x)
 
     def resize(self, *args):
         r"""
-        resize(vdouble1d_t self, std::vector< double >::size_type new_size)
-        resize(vdouble1d_t self, std::vector< double >::size_type new_size, std::vector< double >::value_type const & x)
+        resize(vdouble1d_T self, std::vector< double >::size_type new_size)
+        resize(vdouble1d_T self, std::vector< double >::size_type new_size, std::vector< double >::value_type const & x)
         """
-        return _libBornAgainSim.vdouble1d_t_resize(self, *args)
+        return _libBornAgainSim.vdouble1d_T_resize(self, *args)
 
     def insert(self, *args):
         r"""
-        insert(vdouble1d_t self, std::vector< double >::iterator pos, std::vector< double >::value_type const & x) -> std::vector< double >::iterator
-        insert(vdouble1d_t self, std::vector< double >::iterator pos, std::vector< double >::size_type n, std::vector< double >::value_type const & x)
+        insert(vdouble1d_T self, std::vector< double >::iterator pos, std::vector< double >::value_type const & x) -> std::vector< double >::iterator
+        insert(vdouble1d_T self, std::vector< double >::iterator pos, std::vector< double >::size_type n, std::vector< double >::value_type const & x)
         """
-        return _libBornAgainSim.vdouble1d_t_insert(self, *args)
+        return _libBornAgainSim.vdouble1d_T_insert(self, *args)
 
     def reserve(self, n):
-        r"""reserve(vdouble1d_t self, std::vector< double >::size_type n)"""
-        return _libBornAgainSim.vdouble1d_t_reserve(self, n)
+        r"""reserve(vdouble1d_T self, std::vector< double >::size_type n)"""
+        return _libBornAgainSim.vdouble1d_T_reserve(self, n)
 
     def capacity(self):
-        r"""capacity(vdouble1d_t self) -> std::vector< double >::size_type"""
-        return _libBornAgainSim.vdouble1d_t_capacity(self)
-    __swig_destroy__ = _libBornAgainSim.delete_vdouble1d_t
+        r"""capacity(vdouble1d_T self) -> std::vector< double >::size_type"""
+        return _libBornAgainSim.vdouble1d_T_capacity(self)
+    __swig_destroy__ = _libBornAgainSim.delete_vdouble1d_T
 
-# Register vdouble1d_t in _libBornAgainSim:
-_libBornAgainSim.vdouble1d_t_swigregister(vdouble1d_t)
-class vdouble2d_t(object):
+# Register vdouble1d_T in _libBornAgainSim:
+_libBornAgainSim.vdouble1d_T_swigregister(vdouble1d_T)
+class vdouble2d_T(object):
     r"""Proxy of C++ std::vector< std::vector< double > > class."""
 
     thisown = property(lambda x: x.this.own(), lambda x, v: x.this.own(v), doc="The membership flag")
     __repr__ = _swig_repr
 
     def iterator(self):
-        r"""iterator(vdouble2d_t self) -> SwigPyIterator"""
-        return _libBornAgainSim.vdouble2d_t_iterator(self)
+        r"""iterator(vdouble2d_T self) -> SwigPyIterator"""
+        return _libBornAgainSim.vdouble2d_T_iterator(self)
     def __iter__(self):
         return self.iterator()
 
     def __nonzero__(self):
-        r"""__nonzero__(vdouble2d_t self) -> bool"""
-        return _libBornAgainSim.vdouble2d_t___nonzero__(self)
+        r"""__nonzero__(vdouble2d_T self) -> bool"""
+        return _libBornAgainSim.vdouble2d_T___nonzero__(self)
 
     def __bool__(self):
-        r"""__bool__(vdouble2d_t self) -> bool"""
-        return _libBornAgainSim.vdouble2d_t___bool__(self)
+        r"""__bool__(vdouble2d_T self) -> bool"""
+        return _libBornAgainSim.vdouble2d_T___bool__(self)
 
     def __len__(self):
-        r"""__len__(vdouble2d_t self) -> std::vector< std::vector< double > >::size_type"""
-        return _libBornAgainSim.vdouble2d_t___len__(self)
+        r"""__len__(vdouble2d_T self) -> std::vector< std::vector< double > >::size_type"""
+        return _libBornAgainSim.vdouble2d_T___len__(self)
 
     def __getslice__(self, i, j):
-        r"""__getslice__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j) -> vdouble2d_t"""
-        return _libBornAgainSim.vdouble2d_t___getslice__(self, i, j)
+        r"""__getslice__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j) -> vdouble2d_T"""
+        return _libBornAgainSim.vdouble2d_T___getslice__(self, i, j)
 
     def __setslice__(self, *args):
         r"""
-        __setslice__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j)
-        __setslice__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j, vdouble2d_t v)
+        __setslice__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j)
+        __setslice__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j, vdouble2d_T v)
         """
-        return _libBornAgainSim.vdouble2d_t___setslice__(self, *args)
+        return _libBornAgainSim.vdouble2d_T___setslice__(self, *args)
 
     def __delslice__(self, i, j):
-        r"""__delslice__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j)"""
-        return _libBornAgainSim.vdouble2d_t___delslice__(self, i, j)
+        r"""__delslice__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j)"""
+        return _libBornAgainSim.vdouble2d_T___delslice__(self, i, j)
 
     def __delitem__(self, *args):
         r"""
-        __delitem__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i)
-        __delitem__(vdouble2d_t self, SWIGPY_SLICEOBJECT * slice)
+        __delitem__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i)
+        __delitem__(vdouble2d_T self, SWIGPY_SLICEOBJECT * slice)
         """
-        return _libBornAgainSim.vdouble2d_t___delitem__(self, *args)
+        return _libBornAgainSim.vdouble2d_T___delitem__(self, *args)
 
     def __getitem__(self, *args):
         r"""
-        __getitem__(vdouble2d_t self, SWIGPY_SLICEOBJECT * slice) -> vdouble2d_t
-        __getitem__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i) -> vdouble1d_t
+        __getitem__(vdouble2d_T self, SWIGPY_SLICEOBJECT * slice) -> vdouble2d_T
+        __getitem__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i) -> vdouble1d_T
         """
-        return _libBornAgainSim.vdouble2d_t___getitem__(self, *args)
+        return _libBornAgainSim.vdouble2d_T___getitem__(self, *args)
 
     def __setitem__(self, *args):
         r"""
-        __setitem__(vdouble2d_t self, SWIGPY_SLICEOBJECT * slice, vdouble2d_t v)
-        __setitem__(vdouble2d_t self, SWIGPY_SLICEOBJECT * slice)
-        __setitem__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i, vdouble1d_t x)
+        __setitem__(vdouble2d_T self, SWIGPY_SLICEOBJECT * slice, vdouble2d_T v)
+        __setitem__(vdouble2d_T self, SWIGPY_SLICEOBJECT * slice)
+        __setitem__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i, vdouble1d_T x)
         """
-        return _libBornAgainSim.vdouble2d_t___setitem__(self, *args)
+        return _libBornAgainSim.vdouble2d_T___setitem__(self, *args)
 
     def pop(self):
-        r"""pop(vdouble2d_t self) -> vdouble1d_t"""
-        return _libBornAgainSim.vdouble2d_t_pop(self)
+        r"""pop(vdouble2d_T self) -> vdouble1d_T"""
+        return _libBornAgainSim.vdouble2d_T_pop(self)
 
     def append(self, x):
-        r"""append(vdouble2d_t self, vdouble1d_t x)"""
-        return _libBornAgainSim.vdouble2d_t_append(self, x)
+        r"""append(vdouble2d_T self, vdouble1d_T x)"""
+        return _libBornAgainSim.vdouble2d_T_append(self, x)
 
     def empty(self):
-        r"""empty(vdouble2d_t self) -> bool"""
-        return _libBornAgainSim.vdouble2d_t_empty(self)
+        r"""empty(vdouble2d_T self) -> bool"""
+        return _libBornAgainSim.vdouble2d_T_empty(self)
 
     def size(self):
-        r"""size(vdouble2d_t self) -> std::vector< std::vector< double > >::size_type"""
-        return _libBornAgainSim.vdouble2d_t_size(self)
+        r"""size(vdouble2d_T self) -> std::vector< std::vector< double > >::size_type"""
+        return _libBornAgainSim.vdouble2d_T_size(self)
 
     def swap(self, v):
-        r"""swap(vdouble2d_t self, vdouble2d_t v)"""
-        return _libBornAgainSim.vdouble2d_t_swap(self, v)
+        r"""swap(vdouble2d_T self, vdouble2d_T v)"""
+        return _libBornAgainSim.vdouble2d_T_swap(self, v)
 
     def begin(self):
-        r"""begin(vdouble2d_t self) -> std::vector< std::vector< double > >::iterator"""
-        return _libBornAgainSim.vdouble2d_t_begin(self)
+        r"""begin(vdouble2d_T self) -> std::vector< std::vector< double > >::iterator"""
+        return _libBornAgainSim.vdouble2d_T_begin(self)
 
     def end(self):
-        r"""end(vdouble2d_t self) -> std::vector< std::vector< double > >::iterator"""
-        return _libBornAgainSim.vdouble2d_t_end(self)
+        r"""end(vdouble2d_T self) -> std::vector< std::vector< double > >::iterator"""
+        return _libBornAgainSim.vdouble2d_T_end(self)
 
     def rbegin(self):
-        r"""rbegin(vdouble2d_t self) -> std::vector< std::vector< double > >::reverse_iterator"""
-        return _libBornAgainSim.vdouble2d_t_rbegin(self)
+        r"""rbegin(vdouble2d_T self) -> std::vector< std::vector< double > >::reverse_iterator"""
+        return _libBornAgainSim.vdouble2d_T_rbegin(self)
 
     def rend(self):
-        r"""rend(vdouble2d_t self) -> std::vector< std::vector< double > >::reverse_iterator"""
-        return _libBornAgainSim.vdouble2d_t_rend(self)
+        r"""rend(vdouble2d_T self) -> std::vector< std::vector< double > >::reverse_iterator"""
+        return _libBornAgainSim.vdouble2d_T_rend(self)
 
     def clear(self):
-        r"""clear(vdouble2d_t self)"""
-        return _libBornAgainSim.vdouble2d_t_clear(self)
+        r"""clear(vdouble2d_T self)"""
+        return _libBornAgainSim.vdouble2d_T_clear(self)
 
     def get_allocator(self):
-        r"""get_allocator(vdouble2d_t self) -> std::vector< std::vector< double > >::allocator_type"""
-        return _libBornAgainSim.vdouble2d_t_get_allocator(self)
+        r"""get_allocator(vdouble2d_T self) -> std::vector< std::vector< double > >::allocator_type"""
+        return _libBornAgainSim.vdouble2d_T_get_allocator(self)
 
     def pop_back(self):
-        r"""pop_back(vdouble2d_t self)"""
-        return _libBornAgainSim.vdouble2d_t_pop_back(self)
+        r"""pop_back(vdouble2d_T self)"""
+        return _libBornAgainSim.vdouble2d_T_pop_back(self)
 
     def erase(self, *args):
         r"""
-        erase(vdouble2d_t self, std::vector< std::vector< double > >::iterator pos) -> std::vector< std::vector< double > >::iterator
-        erase(vdouble2d_t self, std::vector< std::vector< double > >::iterator first, std::vector< std::vector< double > >::iterator last) -> std::vector< std::vector< double > >::iterator
+        erase(vdouble2d_T self, std::vector< std::vector< double > >::iterator pos) -> std::vector< std::vector< double > >::iterator
+        erase(vdouble2d_T self, std::vector< std::vector< double > >::iterator first, std::vector< std::vector< double > >::iterator last) -> std::vector< std::vector< double > >::iterator
         """
-        return _libBornAgainSim.vdouble2d_t_erase(self, *args)
+        return _libBornAgainSim.vdouble2d_T_erase(self, *args)
 
     def __init__(self, *args):
         r"""
-        __init__(vdouble2d_t self) -> vdouble2d_t
-        __init__(vdouble2d_t self, vdouble2d_t other) -> vdouble2d_t
-        __init__(vdouble2d_t self, std::vector< std::vector< double > >::size_type size) -> vdouble2d_t
-        __init__(vdouble2d_t self, std::vector< std::vector< double > >::size_type size, vdouble1d_t value) -> vdouble2d_t
+        __init__(vdouble2d_T self) -> vdouble2d_T
+        __init__(vdouble2d_T self, vdouble2d_T other) -> vdouble2d_T
+        __init__(vdouble2d_T self, std::vector< std::vector< double > >::size_type size) -> vdouble2d_T
+        __init__(vdouble2d_T self, std::vector< std::vector< double > >::size_type size, vdouble1d_T value) -> vdouble2d_T
         """
-        _libBornAgainSim.vdouble2d_t_swiginit(self, _libBornAgainSim.new_vdouble2d_t(*args))
+        _libBornAgainSim.vdouble2d_T_swiginit(self, _libBornAgainSim.new_vdouble2d_T(*args))
 
     def push_back(self, x):
-        r"""push_back(vdouble2d_t self, vdouble1d_t x)"""
-        return _libBornAgainSim.vdouble2d_t_push_back(self, x)
+        r"""push_back(vdouble2d_T self, vdouble1d_T x)"""
+        return _libBornAgainSim.vdouble2d_T_push_back(self, x)
 
     def front(self):
-        r"""front(vdouble2d_t self) -> vdouble1d_t"""
-        return _libBornAgainSim.vdouble2d_t_front(self)
+        r"""front(vdouble2d_T self) -> vdouble1d_T"""
+        return _libBornAgainSim.vdouble2d_T_front(self)
 
     def back(self):
-        r"""back(vdouble2d_t self) -> vdouble1d_t"""
-        return _libBornAgainSim.vdouble2d_t_back(self)
+        r"""back(vdouble2d_T self) -> vdouble1d_T"""
+        return _libBornAgainSim.vdouble2d_T_back(self)
 
     def assign(self, n, x):
-        r"""assign(vdouble2d_t self, std::vector< std::vector< double > >::size_type n, vdouble1d_t x)"""
-        return _libBornAgainSim.vdouble2d_t_assign(self, n, x)
+        r"""assign(vdouble2d_T self, std::vector< std::vector< double > >::size_type n, vdouble1d_T x)"""
+        return _libBornAgainSim.vdouble2d_T_assign(self, n, x)
 
     def resize(self, *args):
         r"""
-        resize(vdouble2d_t self, std::vector< std::vector< double > >::size_type new_size)
-        resize(vdouble2d_t self, std::vector< std::vector< double > >::size_type new_size, vdouble1d_t x)
+        resize(vdouble2d_T self, std::vector< std::vector< double > >::size_type new_size)
+        resize(vdouble2d_T self, std::vector< std::vector< double > >::size_type new_size, vdouble1d_T x)
         """
-        return _libBornAgainSim.vdouble2d_t_resize(self, *args)
+        return _libBornAgainSim.vdouble2d_T_resize(self, *args)
 
     def insert(self, *args):
         r"""
-        insert(vdouble2d_t self, std::vector< std::vector< double > >::iterator pos, vdouble1d_t x) -> std::vector< std::vector< double > >::iterator
-        insert(vdouble2d_t self, std::vector< std::vector< double > >::iterator pos, std::vector< std::vector< double > >::size_type n, vdouble1d_t x)
+        insert(vdouble2d_T self, std::vector< std::vector< double > >::iterator pos, vdouble1d_T x) -> std::vector< std::vector< double > >::iterator
+        insert(vdouble2d_T self, std::vector< std::vector< double > >::iterator pos, std::vector< std::vector< double > >::size_type n, vdouble1d_T x)
         """
-        return _libBornAgainSim.vdouble2d_t_insert(self, *args)
+        return _libBornAgainSim.vdouble2d_T_insert(self, *args)
 
     def reserve(self, n):
-        r"""reserve(vdouble2d_t self, std::vector< std::vector< double > >::size_type n)"""
-        return _libBornAgainSim.vdouble2d_t_reserve(self, n)
+        r"""reserve(vdouble2d_T self, std::vector< std::vector< double > >::size_type n)"""
+        return _libBornAgainSim.vdouble2d_T_reserve(self, n)
 
     def capacity(self):
-        r"""capacity(vdouble2d_t self) -> std::vector< std::vector< double > >::size_type"""
-        return _libBornAgainSim.vdouble2d_t_capacity(self)
-    __swig_destroy__ = _libBornAgainSim.delete_vdouble2d_t
+        r"""capacity(vdouble2d_T self) -> std::vector< std::vector< double > >::size_type"""
+        return _libBornAgainSim.vdouble2d_T_capacity(self)
+    __swig_destroy__ = _libBornAgainSim.delete_vdouble2d_T
 
-# Register vdouble2d_t in _libBornAgainSim:
-_libBornAgainSim.vdouble2d_t_swigregister(vdouble2d_t)
-class vector_integer_t(object):
+# Register vdouble2d_T in _libBornAgainSim:
+_libBornAgainSim.vdouble2d_T_swigregister(vdouble2d_T)
+class vector_integer_T(object):
     r"""Proxy of C++ std::vector< int > class."""
 
     thisown = property(lambda x: x.this.own(), lambda x, v: x.this.own(v), doc="The membership flag")
     __repr__ = _swig_repr
 
     def iterator(self):
-        r"""iterator(vector_integer_t self) -> SwigPyIterator"""
-        return _libBornAgainSim.vector_integer_t_iterator(self)
+        r"""iterator(vector_integer_T self) -> SwigPyIterator"""
+        return _libBornAgainSim.vector_integer_T_iterator(self)
     def __iter__(self):
         return self.iterator()
 
     def __nonzero__(self):
-        r"""__nonzero__(vector_integer_t self) -> bool"""
-        return _libBornAgainSim.vector_integer_t___nonzero__(self)
+        r"""__nonzero__(vector_integer_T self) -> bool"""
+        return _libBornAgainSim.vector_integer_T___nonzero__(self)
 
     def __bool__(self):
-        r"""__bool__(vector_integer_t self) -> bool"""
-        return _libBornAgainSim.vector_integer_t___bool__(self)
+        r"""__bool__(vector_integer_T self) -> bool"""
+        return _libBornAgainSim.vector_integer_T___bool__(self)
 
     def __len__(self):
-        r"""__len__(vector_integer_t self) -> std::vector< int >::size_type"""
-        return _libBornAgainSim.vector_integer_t___len__(self)
+        r"""__len__(vector_integer_T self) -> std::vector< int >::size_type"""
+        return _libBornAgainSim.vector_integer_T___len__(self)
 
     def __getslice__(self, i, j):
-        r"""__getslice__(vector_integer_t self, std::vector< int >::difference_type i, std::vector< int >::difference_type j) -> vector_integer_t"""
-        return _libBornAgainSim.vector_integer_t___getslice__(self, i, j)
+        r"""__getslice__(vector_integer_T self, std::vector< int >::difference_type i, std::vector< int >::difference_type j) -> vector_integer_T"""
+        return _libBornAgainSim.vector_integer_T___getslice__(self, i, j)
 
     def __setslice__(self, *args):
         r"""
-        __setslice__(vector_integer_t self, std::vector< int >::difference_type i, std::vector< int >::difference_type j)
-        __setslice__(vector_integer_t self, std::vector< int >::difference_type i, std::vector< int >::difference_type j, vector_integer_t v)
+        __setslice__(vector_integer_T self, std::vector< int >::difference_type i, std::vector< int >::difference_type j)
+        __setslice__(vector_integer_T self, std::vector< int >::difference_type i, std::vector< int >::difference_type j, vector_integer_T v)
         """
-        return _libBornAgainSim.vector_integer_t___setslice__(self, *args)
+        return _libBornAgainSim.vector_integer_T___setslice__(self, *args)
 
     def __delslice__(self, i, j):
-        r"""__delslice__(vector_integer_t self, std::vector< int >::difference_type i, std::vector< int >::difference_type j)"""
-        return _libBornAgainSim.vector_integer_t___delslice__(self, i, j)
+        r"""__delslice__(vector_integer_T self, std::vector< int >::difference_type i, std::vector< int >::difference_type j)"""
+        return _libBornAgainSim.vector_integer_T___delslice__(self, i, j)
 
     def __delitem__(self, *args):
         r"""
-        __delitem__(vector_integer_t self, std::vector< int >::difference_type i)
-        __delitem__(vector_integer_t self, SWIGPY_SLICEOBJECT * slice)
+        __delitem__(vector_integer_T self, std::vector< int >::difference_type i)
+        __delitem__(vector_integer_T self, SWIGPY_SLICEOBJECT * slice)
         """
-        return _libBornAgainSim.vector_integer_t___delitem__(self, *args)
+        return _libBornAgainSim.vector_integer_T___delitem__(self, *args)
 
     def __getitem__(self, *args):
         r"""
-        __getitem__(vector_integer_t self, SWIGPY_SLICEOBJECT * slice) -> vector_integer_t
-        __getitem__(vector_integer_t self, std::vector< int >::difference_type i) -> std::vector< int >::value_type const &
+        __getitem__(vector_integer_T self, SWIGPY_SLICEOBJECT * slice) -> vector_integer_T
+        __getitem__(vector_integer_T self, std::vector< int >::difference_type i) -> std::vector< int >::value_type const &
         """
-        return _libBornAgainSim.vector_integer_t___getitem__(self, *args)
+        return _libBornAgainSim.vector_integer_T___getitem__(self, *args)
 
     def __setitem__(self, *args):
         r"""
-        __setitem__(vector_integer_t self, SWIGPY_SLICEOBJECT * slice, vector_integer_t v)
-        __setitem__(vector_integer_t self, SWIGPY_SLICEOBJECT * slice)
-        __setitem__(vector_integer_t self, std::vector< int >::difference_type i, std::vector< int >::value_type const & x)
+        __setitem__(vector_integer_T self, SWIGPY_SLICEOBJECT * slice, vector_integer_T v)
+        __setitem__(vector_integer_T self, SWIGPY_SLICEOBJECT * slice)
+        __setitem__(vector_integer_T self, std::vector< int >::difference_type i, std::vector< int >::value_type const & x)
         """
-        return _libBornAgainSim.vector_integer_t___setitem__(self, *args)
+        return _libBornAgainSim.vector_integer_T___setitem__(self, *args)
 
     def pop(self):
-        r"""pop(vector_integer_t self) -> std::vector< int >::value_type"""
-        return _libBornAgainSim.vector_integer_t_pop(self)
+        r"""pop(vector_integer_T self) -> std::vector< int >::value_type"""
+        return _libBornAgainSim.vector_integer_T_pop(self)
 
     def append(self, x):
-        r"""append(vector_integer_t self, std::vector< int >::value_type const & x)"""
-        return _libBornAgainSim.vector_integer_t_append(self, x)
+        r"""append(vector_integer_T self, std::vector< int >::value_type const & x)"""
+        return _libBornAgainSim.vector_integer_T_append(self, x)
 
     def empty(self):
-        r"""empty(vector_integer_t self) -> bool"""
-        return _libBornAgainSim.vector_integer_t_empty(self)
+        r"""empty(vector_integer_T self) -> bool"""
+        return _libBornAgainSim.vector_integer_T_empty(self)
 
     def size(self):
-        r"""size(vector_integer_t self) -> std::vector< int >::size_type"""
-        return _libBornAgainSim.vector_integer_t_size(self)
+        r"""size(vector_integer_T self) -> std::vector< int >::size_type"""
+        return _libBornAgainSim.vector_integer_T_size(self)
 
     def swap(self, v):
-        r"""swap(vector_integer_t self, vector_integer_t v)"""
-        return _libBornAgainSim.vector_integer_t_swap(self, v)
+        r"""swap(vector_integer_T self, vector_integer_T v)"""
+        return _libBornAgainSim.vector_integer_T_swap(self, v)
 
     def begin(self):
-        r"""begin(vector_integer_t self) -> std::vector< int >::iterator"""
-        return _libBornAgainSim.vector_integer_t_begin(self)
+        r"""begin(vector_integer_T self) -> std::vector< int >::iterator"""
+        return _libBornAgainSim.vector_integer_T_begin(self)
 
     def end(self):
-        r"""end(vector_integer_t self) -> std::vector< int >::iterator"""
-        return _libBornAgainSim.vector_integer_t_end(self)
+        r"""end(vector_integer_T self) -> std::vector< int >::iterator"""
+        return _libBornAgainSim.vector_integer_T_end(self)
 
     def rbegin(self):
-        r"""rbegin(vector_integer_t self) -> std::vector< int >::reverse_iterator"""
-        return _libBornAgainSim.vector_integer_t_rbegin(self)
+        r"""rbegin(vector_integer_T self) -> std::vector< int >::reverse_iterator"""
+        return _libBornAgainSim.vector_integer_T_rbegin(self)
 
     def rend(self):
-        r"""rend(vector_integer_t self) -> std::vector< int >::reverse_iterator"""
-        return _libBornAgainSim.vector_integer_t_rend(self)
+        r"""rend(vector_integer_T self) -> std::vector< int >::reverse_iterator"""
+        return _libBornAgainSim.vector_integer_T_rend(self)
 
     def clear(self):
-        r"""clear(vector_integer_t self)"""
-        return _libBornAgainSim.vector_integer_t_clear(self)
+        r"""clear(vector_integer_T self)"""
+        return _libBornAgainSim.vector_integer_T_clear(self)
 
     def get_allocator(self):
-        r"""get_allocator(vector_integer_t self) -> std::vector< int >::allocator_type"""
-        return _libBornAgainSim.vector_integer_t_get_allocator(self)
+        r"""get_allocator(vector_integer_T self) -> std::vector< int >::allocator_type"""
+        return _libBornAgainSim.vector_integer_T_get_allocator(self)
 
     def pop_back(self):
-        r"""pop_back(vector_integer_t self)"""
-        return _libBornAgainSim.vector_integer_t_pop_back(self)
+        r"""pop_back(vector_integer_T self)"""
+        return _libBornAgainSim.vector_integer_T_pop_back(self)
 
     def erase(self, *args):
         r"""
-        erase(vector_integer_t self, std::vector< int >::iterator pos) -> std::vector< int >::iterator
-        erase(vector_integer_t self, std::vector< int >::iterator first, std::vector< int >::iterator last) -> std::vector< int >::iterator
+        erase(vector_integer_T self, std::vector< int >::iterator pos) -> std::vector< int >::iterator
+        erase(vector_integer_T self, std::vector< int >::iterator first, std::vector< int >::iterator last) -> std::vector< int >::iterator
         """
-        return _libBornAgainSim.vector_integer_t_erase(self, *args)
+        return _libBornAgainSim.vector_integer_T_erase(self, *args)
 
     def __init__(self, *args):
         r"""
-        __init__(vector_integer_t self) -> vector_integer_t
-        __init__(vector_integer_t self, vector_integer_t other) -> vector_integer_t
-        __init__(vector_integer_t self, std::vector< int >::size_type size) -> vector_integer_t
-        __init__(vector_integer_t self, std::vector< int >::size_type size, std::vector< int >::value_type const & value) -> vector_integer_t
+        __init__(vector_integer_T self) -> vector_integer_T
+        __init__(vector_integer_T self, vector_integer_T other) -> vector_integer_T
+        __init__(vector_integer_T self, std::vector< int >::size_type size) -> vector_integer_T
+        __init__(vector_integer_T self, std::vector< int >::size_type size, std::vector< int >::value_type const & value) -> vector_integer_T
         """
-        _libBornAgainSim.vector_integer_t_swiginit(self, _libBornAgainSim.new_vector_integer_t(*args))
+        _libBornAgainSim.vector_integer_T_swiginit(self, _libBornAgainSim.new_vector_integer_T(*args))
 
     def push_back(self, x):
-        r"""push_back(vector_integer_t self, std::vector< int >::value_type const & x)"""
-        return _libBornAgainSim.vector_integer_t_push_back(self, x)
+        r"""push_back(vector_integer_T self, std::vector< int >::value_type const & x)"""
+        return _libBornAgainSim.vector_integer_T_push_back(self, x)
 
     def front(self):
-        r"""front(vector_integer_t self) -> std::vector< int >::value_type const &"""
-        return _libBornAgainSim.vector_integer_t_front(self)
+        r"""front(vector_integer_T self) -> std::vector< int >::value_type const &"""
+        return _libBornAgainSim.vector_integer_T_front(self)
 
     def back(self):
-        r"""back(vector_integer_t self) -> std::vector< int >::value_type const &"""
-        return _libBornAgainSim.vector_integer_t_back(self)
+        r"""back(vector_integer_T self) -> std::vector< int >::value_type const &"""
+        return _libBornAgainSim.vector_integer_T_back(self)
 
     def assign(self, n, x):
-        r"""assign(vector_integer_t self, std::vector< int >::size_type n, std::vector< int >::value_type const & x)"""
-        return _libBornAgainSim.vector_integer_t_assign(self, n, x)
+        r"""assign(vector_integer_T self, std::vector< int >::size_type n, std::vector< int >::value_type const & x)"""
+        return _libBornAgainSim.vector_integer_T_assign(self, n, x)
 
     def resize(self, *args):
         r"""
-        resize(vector_integer_t self, std::vector< int >::size_type new_size)
-        resize(vector_integer_t self, std::vector< int >::size_type new_size, std::vector< int >::value_type const & x)
+        resize(vector_integer_T self, std::vector< int >::size_type new_size)
+        resize(vector_integer_T self, std::vector< int >::size_type new_size, std::vector< int >::value_type const & x)
         """
-        return _libBornAgainSim.vector_integer_t_resize(self, *args)
+        return _libBornAgainSim.vector_integer_T_resize(self, *args)
 
     def insert(self, *args):
         r"""
-        insert(vector_integer_t self, std::vector< int >::iterator pos, std::vector< int >::value_type const & x) -> std::vector< int >::iterator
-        insert(vector_integer_t self, std::vector< int >::iterator pos, std::vector< int >::size_type n, std::vector< int >::value_type const & x)
+        insert(vector_integer_T self, std::vector< int >::iterator pos, std::vector< int >::value_type const & x) -> std::vector< int >::iterator
+        insert(vector_integer_T self, std::vector< int >::iterator pos, std::vector< int >::size_type n, std::vector< int >::value_type const & x)
         """
-        return _libBornAgainSim.vector_integer_t_insert(self, *args)
+        return _libBornAgainSim.vector_integer_T_insert(self, *args)
 
     def reserve(self, n):
-        r"""reserve(vector_integer_t self, std::vector< int >::size_type n)"""
-        return _libBornAgainSim.vector_integer_t_reserve(self, n)
+        r"""reserve(vector_integer_T self, std::vector< int >::size_type n)"""
+        return _libBornAgainSim.vector_integer_T_reserve(self, n)
 
     def capacity(self):
-        r"""capacity(vector_integer_t self) -> std::vector< int >::size_type"""
-        return _libBornAgainSim.vector_integer_t_capacity(self)
-    __swig_destroy__ = _libBornAgainSim.delete_vector_integer_t
+        r"""capacity(vector_integer_T self) -> std::vector< int >::size_type"""
+        return _libBornAgainSim.vector_integer_T_capacity(self)
+    __swig_destroy__ = _libBornAgainSim.delete_vector_integer_T
 
-# Register vector_integer_t in _libBornAgainSim:
-_libBornAgainSim.vector_integer_t_swigregister(vector_integer_t)
-class vinteger2d_t(object):
+# Register vector_integer_T in _libBornAgainSim:
+_libBornAgainSim.vector_integer_T_swigregister(vector_integer_T)
+class vinteger2d_T(object):
     r"""Proxy of C++ std::vector< std::vector< int > > class."""
 
     thisown = property(lambda x: x.this.own(), lambda x, v: x.this.own(v), doc="The membership flag")
     __repr__ = _swig_repr
 
     def iterator(self):
-        r"""iterator(vinteger2d_t self) -> SwigPyIterator"""
-        return _libBornAgainSim.vinteger2d_t_iterator(self)
+        r"""iterator(vinteger2d_T self) -> SwigPyIterator"""
+        return _libBornAgainSim.vinteger2d_T_iterator(self)
     def __iter__(self):
         return self.iterator()
 
     def __nonzero__(self):
-        r"""__nonzero__(vinteger2d_t self) -> bool"""
-        return _libBornAgainSim.vinteger2d_t___nonzero__(self)
+        r"""__nonzero__(vinteger2d_T self) -> bool"""
+        return _libBornAgainSim.vinteger2d_T___nonzero__(self)
 
     def __bool__(self):
-        r"""__bool__(vinteger2d_t self) -> bool"""
-        return _libBornAgainSim.vinteger2d_t___bool__(self)
+        r"""__bool__(vinteger2d_T self) -> bool"""
+        return _libBornAgainSim.vinteger2d_T___bool__(self)
 
     def __len__(self):
-        r"""__len__(vinteger2d_t self) -> std::vector< std::vector< int > >::size_type"""
-        return _libBornAgainSim.vinteger2d_t___len__(self)
+        r"""__len__(vinteger2d_T self) -> std::vector< std::vector< int > >::size_type"""
+        return _libBornAgainSim.vinteger2d_T___len__(self)
 
     def __getslice__(self, i, j):
-        r"""__getslice__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j) -> vinteger2d_t"""
-        return _libBornAgainSim.vinteger2d_t___getslice__(self, i, j)
+        r"""__getslice__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j) -> vinteger2d_T"""
+        return _libBornAgainSim.vinteger2d_T___getslice__(self, i, j)
 
     def __setslice__(self, *args):
         r"""
-        __setslice__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j)
-        __setslice__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j, vinteger2d_t v)
+        __setslice__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j)
+        __setslice__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j, vinteger2d_T v)
         """
-        return _libBornAgainSim.vinteger2d_t___setslice__(self, *args)
+        return _libBornAgainSim.vinteger2d_T___setslice__(self, *args)
 
     def __delslice__(self, i, j):
-        r"""__delslice__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j)"""
-        return _libBornAgainSim.vinteger2d_t___delslice__(self, i, j)
+        r"""__delslice__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j)"""
+        return _libBornAgainSim.vinteger2d_T___delslice__(self, i, j)
 
     def __delitem__(self, *args):
         r"""
-        __delitem__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i)
-        __delitem__(vinteger2d_t self, SWIGPY_SLICEOBJECT * slice)
+        __delitem__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i)
+        __delitem__(vinteger2d_T self, SWIGPY_SLICEOBJECT * slice)
         """
-        return _libBornAgainSim.vinteger2d_t___delitem__(self, *args)
+        return _libBornAgainSim.vinteger2d_T___delitem__(self, *args)
 
     def __getitem__(self, *args):
         r"""
-        __getitem__(vinteger2d_t self, SWIGPY_SLICEOBJECT * slice) -> vinteger2d_t
-        __getitem__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i) -> vector_integer_t
+        __getitem__(vinteger2d_T self, SWIGPY_SLICEOBJECT * slice) -> vinteger2d_T
+        __getitem__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i) -> vector_integer_T
         """
-        return _libBornAgainSim.vinteger2d_t___getitem__(self, *args)
+        return _libBornAgainSim.vinteger2d_T___getitem__(self, *args)
 
     def __setitem__(self, *args):
         r"""
-        __setitem__(vinteger2d_t self, SWIGPY_SLICEOBJECT * slice, vinteger2d_t v)
-        __setitem__(vinteger2d_t self, SWIGPY_SLICEOBJECT * slice)
-        __setitem__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i, vector_integer_t x)
+        __setitem__(vinteger2d_T self, SWIGPY_SLICEOBJECT * slice, vinteger2d_T v)
+        __setitem__(vinteger2d_T self, SWIGPY_SLICEOBJECT * slice)
+        __setitem__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i, vector_integer_T x)
         """
-        return _libBornAgainSim.vinteger2d_t___setitem__(self, *args)
+        return _libBornAgainSim.vinteger2d_T___setitem__(self, *args)
 
     def pop(self):
-        r"""pop(vinteger2d_t self) -> vector_integer_t"""
-        return _libBornAgainSim.vinteger2d_t_pop(self)
+        r"""pop(vinteger2d_T self) -> vector_integer_T"""
+        return _libBornAgainSim.vinteger2d_T_pop(self)
 
     def append(self, x):
-        r"""append(vinteger2d_t self, vector_integer_t x)"""
-        return _libBornAgainSim.vinteger2d_t_append(self, x)
+        r"""append(vinteger2d_T self, vector_integer_T x)"""
+        return _libBornAgainSim.vinteger2d_T_append(self, x)
 
     def empty(self):
-        r"""empty(vinteger2d_t self) -> bool"""
-        return _libBornAgainSim.vinteger2d_t_empty(self)
+        r"""empty(vinteger2d_T self) -> bool"""
+        return _libBornAgainSim.vinteger2d_T_empty(self)
 
     def size(self):
-        r"""size(vinteger2d_t self) -> std::vector< std::vector< int > >::size_type"""
-        return _libBornAgainSim.vinteger2d_t_size(self)
+        r"""size(vinteger2d_T self) -> std::vector< std::vector< int > >::size_type"""
+        return _libBornAgainSim.vinteger2d_T_size(self)
 
     def swap(self, v):
-        r"""swap(vinteger2d_t self, vinteger2d_t v)"""
-        return _libBornAgainSim.vinteger2d_t_swap(self, v)
+        r"""swap(vinteger2d_T self, vinteger2d_T v)"""
+        return _libBornAgainSim.vinteger2d_T_swap(self, v)
 
     def begin(self):
-        r"""begin(vinteger2d_t self) -> std::vector< std::vector< int > >::iterator"""
-        return _libBornAgainSim.vinteger2d_t_begin(self)
+        r"""begin(vinteger2d_T self) -> std::vector< std::vector< int > >::iterator"""
+        return _libBornAgainSim.vinteger2d_T_begin(self)
 
     def end(self):
-        r"""end(vinteger2d_t self) -> std::vector< std::vector< int > >::iterator"""
-        return _libBornAgainSim.vinteger2d_t_end(self)
+        r"""end(vinteger2d_T self) -> std::vector< std::vector< int > >::iterator"""
+        return _libBornAgainSim.vinteger2d_T_end(self)
 
     def rbegin(self):
-        r"""rbegin(vinteger2d_t self) -> std::vector< std::vector< int > >::reverse_iterator"""
-        return _libBornAgainSim.vinteger2d_t_rbegin(self)
+        r"""rbegin(vinteger2d_T self) -> std::vector< std::vector< int > >::reverse_iterator"""
+        return _libBornAgainSim.vinteger2d_T_rbegin(self)
 
     def rend(self):
-        r"""rend(vinteger2d_t self) -> std::vector< std::vector< int > >::reverse_iterator"""
-        return _libBornAgainSim.vinteger2d_t_rend(self)
+        r"""rend(vinteger2d_T self) -> std::vector< std::vector< int > >::reverse_iterator"""
+        return _libBornAgainSim.vinteger2d_T_rend(self)
 
     def clear(self):
-        r"""clear(vinteger2d_t self)"""
-        return _libBornAgainSim.vinteger2d_t_clear(self)
+        r"""clear(vinteger2d_T self)"""
+        return _libBornAgainSim.vinteger2d_T_clear(self)
 
     def get_allocator(self):
-        r"""get_allocator(vinteger2d_t self) -> std::vector< std::vector< int > >::allocator_type"""
-        return _libBornAgainSim.vinteger2d_t_get_allocator(self)
+        r"""get_allocator(vinteger2d_T self) -> std::vector< std::vector< int > >::allocator_type"""
+        return _libBornAgainSim.vinteger2d_T_get_allocator(self)
 
     def pop_back(self):
-        r"""pop_back(vinteger2d_t self)"""
-        return _libBornAgainSim.vinteger2d_t_pop_back(self)
+        r"""pop_back(vinteger2d_T self)"""
+        return _libBornAgainSim.vinteger2d_T_pop_back(self)
 
     def erase(self, *args):
         r"""
-        erase(vinteger2d_t self, std::vector< std::vector< int > >::iterator pos) -> std::vector< std::vector< int > >::iterator
-        erase(vinteger2d_t self, std::vector< std::vector< int > >::iterator first, std::vector< std::vector< int > >::iterator last) -> std::vector< std::vector< int > >::iterator
+        erase(vinteger2d_T self, std::vector< std::vector< int > >::iterator pos) -> std::vector< std::vector< int > >::iterator
+        erase(vinteger2d_T self, std::vector< std::vector< int > >::iterator first, std::vector< std::vector< int > >::iterator last) -> std::vector< std::vector< int > >::iterator
         """
-        return _libBornAgainSim.vinteger2d_t_erase(self, *args)
+        return _libBornAgainSim.vinteger2d_T_erase(self, *args)
 
     def __init__(self, *args):
         r"""
-        __init__(vinteger2d_t self) -> vinteger2d_t
-        __init__(vinteger2d_t self, vinteger2d_t other) -> vinteger2d_t
-        __init__(vinteger2d_t self, std::vector< std::vector< int > >::size_type size) -> vinteger2d_t
-        __init__(vinteger2d_t self, std::vector< std::vector< int > >::size_type size, vector_integer_t value) -> vinteger2d_t
+        __init__(vinteger2d_T self) -> vinteger2d_T
+        __init__(vinteger2d_T self, vinteger2d_T other) -> vinteger2d_T
+        __init__(vinteger2d_T self, std::vector< std::vector< int > >::size_type size) -> vinteger2d_T
+        __init__(vinteger2d_T self, std::vector< std::vector< int > >::size_type size, vector_integer_T value) -> vinteger2d_T
         """
-        _libBornAgainSim.vinteger2d_t_swiginit(self, _libBornAgainSim.new_vinteger2d_t(*args))
+        _libBornAgainSim.vinteger2d_T_swiginit(self, _libBornAgainSim.new_vinteger2d_T(*args))
 
     def push_back(self, x):
-        r"""push_back(vinteger2d_t self, vector_integer_t x)"""
-        return _libBornAgainSim.vinteger2d_t_push_back(self, x)
+        r"""push_back(vinteger2d_T self, vector_integer_T x)"""
+        return _libBornAgainSim.vinteger2d_T_push_back(self, x)
 
     def front(self):
-        r"""front(vinteger2d_t self) -> vector_integer_t"""
-        return _libBornAgainSim.vinteger2d_t_front(self)
+        r"""front(vinteger2d_T self) -> vector_integer_T"""
+        return _libBornAgainSim.vinteger2d_T_front(self)
 
     def back(self):
-        r"""back(vinteger2d_t self) -> vector_integer_t"""
-        return _libBornAgainSim.vinteger2d_t_back(self)
+        r"""back(vinteger2d_T self) -> vector_integer_T"""
+        return _libBornAgainSim.vinteger2d_T_back(self)
 
     def assign(self, n, x):
-        r"""assign(vinteger2d_t self, std::vector< std::vector< int > >::size_type n, vector_integer_t x)"""
-        return _libBornAgainSim.vinteger2d_t_assign(self, n, x)
+        r"""assign(vinteger2d_T self, std::vector< std::vector< int > >::size_type n, vector_integer_T x)"""
+        return _libBornAgainSim.vinteger2d_T_assign(self, n, x)
 
     def resize(self, *args):
         r"""
-        resize(vinteger2d_t self, std::vector< std::vector< int > >::size_type new_size)
-        resize(vinteger2d_t self, std::vector< std::vector< int > >::size_type new_size, vector_integer_t x)
+        resize(vinteger2d_T self, std::vector< std::vector< int > >::size_type new_size)
+        resize(vinteger2d_T self, std::vector< std::vector< int > >::size_type new_size, vector_integer_T x)
         """
-        return _libBornAgainSim.vinteger2d_t_resize(self, *args)
+        return _libBornAgainSim.vinteger2d_T_resize(self, *args)
 
     def insert(self, *args):
         r"""
-        insert(vinteger2d_t self, std::vector< std::vector< int > >::iterator pos, vector_integer_t x) -> std::vector< std::vector< int > >::iterator
-        insert(vinteger2d_t self, std::vector< std::vector< int > >::iterator pos, std::vector< std::vector< int > >::size_type n, vector_integer_t x)
+        insert(vinteger2d_T self, std::vector< std::vector< int > >::iterator pos, vector_integer_T x) -> std::vector< std::vector< int > >::iterator
+        insert(vinteger2d_T self, std::vector< std::vector< int > >::iterator pos, std::vector< std::vector< int > >::size_type n, vector_integer_T x)
         """
-        return _libBornAgainSim.vinteger2d_t_insert(self, *args)
+        return _libBornAgainSim.vinteger2d_T_insert(self, *args)
 
     def reserve(self, n):
-        r"""reserve(vinteger2d_t self, std::vector< std::vector< int > >::size_type n)"""
-        return _libBornAgainSim.vinteger2d_t_reserve(self, n)
+        r"""reserve(vinteger2d_T self, std::vector< std::vector< int > >::size_type n)"""
+        return _libBornAgainSim.vinteger2d_T_reserve(self, n)
 
     def capacity(self):
-        r"""capacity(vinteger2d_t self) -> std::vector< std::vector< int > >::size_type"""
-        return _libBornAgainSim.vinteger2d_t_capacity(self)
-    __swig_destroy__ = _libBornAgainSim.delete_vinteger2d_t
+        r"""capacity(vinteger2d_T self) -> std::vector< std::vector< int > >::size_type"""
+        return _libBornAgainSim.vinteger2d_T_capacity(self)
+    __swig_destroy__ = _libBornAgainSim.delete_vinteger2d_T
 
-# Register vinteger2d_t in _libBornAgainSim:
-_libBornAgainSim.vinteger2d_t_swigregister(vinteger2d_t)
-class vector_longinteger_t(object):
+# Register vinteger2d_T in _libBornAgainSim:
+_libBornAgainSim.vinteger2d_T_swigregister(vinteger2d_T)
+class vector_longinteger_T(object):
     r"""Proxy of C++ std::vector< unsigned long > class."""
 
     thisown = property(lambda x: x.this.own(), lambda x, v: x.this.own(v), doc="The membership flag")
     __repr__ = _swig_repr
 
     def iterator(self):
-        r"""iterator(vector_longinteger_t self) -> SwigPyIterator"""
-        return _libBornAgainSim.vector_longinteger_t_iterator(self)
+        r"""iterator(vector_longinteger_T self) -> SwigPyIterator"""
+        return _libBornAgainSim.vector_longinteger_T_iterator(self)
     def __iter__(self):
         return self.iterator()
 
     def __nonzero__(self):
-        r"""__nonzero__(vector_longinteger_t self) -> bool"""
-        return _libBornAgainSim.vector_longinteger_t___nonzero__(self)
+        r"""__nonzero__(vector_longinteger_T self) -> bool"""
+        return _libBornAgainSim.vector_longinteger_T___nonzero__(self)
 
     def __bool__(self):
-        r"""__bool__(vector_longinteger_t self) -> bool"""
-        return _libBornAgainSim.vector_longinteger_t___bool__(self)
+        r"""__bool__(vector_longinteger_T self) -> bool"""
+        return _libBornAgainSim.vector_longinteger_T___bool__(self)
 
     def __len__(self):
-        r"""__len__(vector_longinteger_t self) -> std::vector< unsigned long >::size_type"""
-        return _libBornAgainSim.vector_longinteger_t___len__(self)
+        r"""__len__(vector_longinteger_T self) -> std::vector< unsigned long >::size_type"""
+        return _libBornAgainSim.vector_longinteger_T___len__(self)
 
     def __getslice__(self, i, j):
-        r"""__getslice__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j) -> vector_longinteger_t"""
-        return _libBornAgainSim.vector_longinteger_t___getslice__(self, i, j)
+        r"""__getslice__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j) -> vector_longinteger_T"""
+        return _libBornAgainSim.vector_longinteger_T___getslice__(self, i, j)
 
     def __setslice__(self, *args):
         r"""
-        __setslice__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j)
-        __setslice__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j, vector_longinteger_t v)
+        __setslice__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j)
+        __setslice__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j, vector_longinteger_T v)
         """
-        return _libBornAgainSim.vector_longinteger_t___setslice__(self, *args)
+        return _libBornAgainSim.vector_longinteger_T___setslice__(self, *args)
 
     def __delslice__(self, i, j):
-        r"""__delslice__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j)"""
-        return _libBornAgainSim.vector_longinteger_t___delslice__(self, i, j)
+        r"""__delslice__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j)"""
+        return _libBornAgainSim.vector_longinteger_T___delslice__(self, i, j)
 
     def __delitem__(self, *args):
         r"""
-        __delitem__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i)
-        __delitem__(vector_longinteger_t self, SWIGPY_SLICEOBJECT * slice)
+        __delitem__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i)
+        __delitem__(vector_longinteger_T self, SWIGPY_SLICEOBJECT * slice)
         """
-        return _libBornAgainSim.vector_longinteger_t___delitem__(self, *args)
+        return _libBornAgainSim.vector_longinteger_T___delitem__(self, *args)
 
     def __getitem__(self, *args):
         r"""
-        __getitem__(vector_longinteger_t self, SWIGPY_SLICEOBJECT * slice) -> vector_longinteger_t
-        __getitem__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i) -> std::vector< unsigned long >::value_type const &
+        __getitem__(vector_longinteger_T self, SWIGPY_SLICEOBJECT * slice) -> vector_longinteger_T
+        __getitem__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i) -> std::vector< unsigned long >::value_type const &
         """
-        return _libBornAgainSim.vector_longinteger_t___getitem__(self, *args)
+        return _libBornAgainSim.vector_longinteger_T___getitem__(self, *args)
 
     def __setitem__(self, *args):
         r"""
-        __setitem__(vector_longinteger_t self, SWIGPY_SLICEOBJECT * slice, vector_longinteger_t v)
-        __setitem__(vector_longinteger_t self, SWIGPY_SLICEOBJECT * slice)
-        __setitem__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::value_type const & x)
+        __setitem__(vector_longinteger_T self, SWIGPY_SLICEOBJECT * slice, vector_longinteger_T v)
+        __setitem__(vector_longinteger_T self, SWIGPY_SLICEOBJECT * slice)
+        __setitem__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::value_type const & x)
         """
-        return _libBornAgainSim.vector_longinteger_t___setitem__(self, *args)
+        return _libBornAgainSim.vector_longinteger_T___setitem__(self, *args)
 
     def pop(self):
-        r"""pop(vector_longinteger_t self) -> std::vector< unsigned long >::value_type"""
-        return _libBornAgainSim.vector_longinteger_t_pop(self)
+        r"""pop(vector_longinteger_T self) -> std::vector< unsigned long >::value_type"""
+        return _libBornAgainSim.vector_longinteger_T_pop(self)
 
     def append(self, x):
-        r"""append(vector_longinteger_t self, std::vector< unsigned long >::value_type const & x)"""
-        return _libBornAgainSim.vector_longinteger_t_append(self, x)
+        r"""append(vector_longinteger_T self, std::vector< unsigned long >::value_type const & x)"""
+        return _libBornAgainSim.vector_longinteger_T_append(self, x)
 
     def empty(self):
-        r"""empty(vector_longinteger_t self) -> bool"""
-        return _libBornAgainSim.vector_longinteger_t_empty(self)
+        r"""empty(vector_longinteger_T self) -> bool"""
+        return _libBornAgainSim.vector_longinteger_T_empty(self)
 
     def size(self):
-        r"""size(vector_longinteger_t self) -> std::vector< unsigned long >::size_type"""
-        return _libBornAgainSim.vector_longinteger_t_size(self)
+        r"""size(vector_longinteger_T self) -> std::vector< unsigned long >::size_type"""
+        return _libBornAgainSim.vector_longinteger_T_size(self)
 
     def swap(self, v):
-        r"""swap(vector_longinteger_t self, vector_longinteger_t v)"""
-        return _libBornAgainSim.vector_longinteger_t_swap(self, v)
+        r"""swap(vector_longinteger_T self, vector_longinteger_T v)"""
+        return _libBornAgainSim.vector_longinteger_T_swap(self, v)
 
     def begin(self):
-        r"""begin(vector_longinteger_t self) -> std::vector< unsigned long >::iterator"""
-        return _libBornAgainSim.vector_longinteger_t_begin(self)
+        r"""begin(vector_longinteger_T self) -> std::vector< unsigned long >::iterator"""
+        return _libBornAgainSim.vector_longinteger_T_begin(self)
 
     def end(self):
-        r"""end(vector_longinteger_t self) -> std::vector< unsigned long >::iterator"""
-        return _libBornAgainSim.vector_longinteger_t_end(self)
+        r"""end(vector_longinteger_T self) -> std::vector< unsigned long >::iterator"""
+        return _libBornAgainSim.vector_longinteger_T_end(self)
 
     def rbegin(self):
-        r"""rbegin(vector_longinteger_t self) -> std::vector< unsigned long >::reverse_iterator"""
-        return _libBornAgainSim.vector_longinteger_t_rbegin(self)
+        r"""rbegin(vector_longinteger_T self) -> std::vector< unsigned long >::reverse_iterator"""
+        return _libBornAgainSim.vector_longinteger_T_rbegin(self)
 
     def rend(self):
-        r"""rend(vector_longinteger_t self) -> std::vector< unsigned long >::reverse_iterator"""
-        return _libBornAgainSim.vector_longinteger_t_rend(self)
+        r"""rend(vector_longinteger_T self) -> std::vector< unsigned long >::reverse_iterator"""
+        return _libBornAgainSim.vector_longinteger_T_rend(self)
 
     def clear(self):
-        r"""clear(vector_longinteger_t self)"""
-        return _libBornAgainSim.vector_longinteger_t_clear(self)
+        r"""clear(vector_longinteger_T self)"""
+        return _libBornAgainSim.vector_longinteger_T_clear(self)
 
     def get_allocator(self):
-        r"""get_allocator(vector_longinteger_t self) -> std::vector< unsigned long >::allocator_type"""
-        return _libBornAgainSim.vector_longinteger_t_get_allocator(self)
+        r"""get_allocator(vector_longinteger_T self) -> std::vector< unsigned long >::allocator_type"""
+        return _libBornAgainSim.vector_longinteger_T_get_allocator(self)
 
     def pop_back(self):
-        r"""pop_back(vector_longinteger_t self)"""
-        return _libBornAgainSim.vector_longinteger_t_pop_back(self)
+        r"""pop_back(vector_longinteger_T self)"""
+        return _libBornAgainSim.vector_longinteger_T_pop_back(self)
 
     def erase(self, *args):
         r"""
-        erase(vector_longinteger_t self, std::vector< unsigned long >::iterator pos) -> std::vector< unsigned long >::iterator
-        erase(vector_longinteger_t self, std::vector< unsigned long >::iterator first, std::vector< unsigned long >::iterator last) -> std::vector< unsigned long >::iterator
+        erase(vector_longinteger_T self, std::vector< unsigned long >::iterator pos) -> std::vector< unsigned long >::iterator
+        erase(vector_longinteger_T self, std::vector< unsigned long >::iterator first, std::vector< unsigned long >::iterator last) -> std::vector< unsigned long >::iterator
         """
-        return _libBornAgainSim.vector_longinteger_t_erase(self, *args)
+        return _libBornAgainSim.vector_longinteger_T_erase(self, *args)
 
     def __init__(self, *args):
         r"""
-        __init__(vector_longinteger_t self) -> vector_longinteger_t
-        __init__(vector_longinteger_t self, vector_longinteger_t other) -> vector_longinteger_t
-        __init__(vector_longinteger_t self, std::vector< unsigned long >::size_type size) -> vector_longinteger_t
-        __init__(vector_longinteger_t self, std::vector< unsigned long >::size_type size, std::vector< unsigned long >::value_type const & value) -> vector_longinteger_t
+        __init__(vector_longinteger_T self) -> vector_longinteger_T
+        __init__(vector_longinteger_T self, vector_longinteger_T other) -> vector_longinteger_T
+        __init__(vector_longinteger_T self, std::vector< unsigned long >::size_type size) -> vector_longinteger_T
+        __init__(vector_longinteger_T self, std::vector< unsigned long >::size_type size, std::vector< unsigned long >::value_type const & value) -> vector_longinteger_T
         """
-        _libBornAgainSim.vector_longinteger_t_swiginit(self, _libBornAgainSim.new_vector_longinteger_t(*args))
+        _libBornAgainSim.vector_longinteger_T_swiginit(self, _libBornAgainSim.new_vector_longinteger_T(*args))
 
     def push_back(self, x):
-        r"""push_back(vector_longinteger_t self, std::vector< unsigned long >::value_type const & x)"""
-        return _libBornAgainSim.vector_longinteger_t_push_back(self, x)
+        r"""push_back(vector_longinteger_T self, std::vector< unsigned long >::value_type const & x)"""
+        return _libBornAgainSim.vector_longinteger_T_push_back(self, x)
 
     def front(self):
-        r"""front(vector_longinteger_t self) -> std::vector< unsigned long >::value_type const &"""
-        return _libBornAgainSim.vector_longinteger_t_front(self)
+        r"""front(vector_longinteger_T self) -> std::vector< unsigned long >::value_type const &"""
+        return _libBornAgainSim.vector_longinteger_T_front(self)
 
     def back(self):
-        r"""back(vector_longinteger_t self) -> std::vector< unsigned long >::value_type const &"""
-        return _libBornAgainSim.vector_longinteger_t_back(self)
+        r"""back(vector_longinteger_T self) -> std::vector< unsigned long >::value_type const &"""
+        return _libBornAgainSim.vector_longinteger_T_back(self)
 
     def assign(self, n, x):
-        r"""assign(vector_longinteger_t self, std::vector< unsigned long >::size_type n, std::vector< unsigned long >::value_type const & x)"""
-        return _libBornAgainSim.vector_longinteger_t_assign(self, n, x)
+        r"""assign(vector_longinteger_T self, std::vector< unsigned long >::size_type n, std::vector< unsigned long >::value_type const & x)"""
+        return _libBornAgainSim.vector_longinteger_T_assign(self, n, x)
 
     def resize(self, *args):
         r"""
-        resize(vector_longinteger_t self, std::vector< unsigned long >::size_type new_size)
-        resize(vector_longinteger_t self, std::vector< unsigned long >::size_type new_size, std::vector< unsigned long >::value_type const & x)
+        resize(vector_longinteger_T self, std::vector< unsigned long >::size_type new_size)
+        resize(vector_longinteger_T self, std::vector< unsigned long >::size_type new_size, std::vector< unsigned long >::value_type const & x)
         """
-        return _libBornAgainSim.vector_longinteger_t_resize(self, *args)
+        return _libBornAgainSim.vector_longinteger_T_resize(self, *args)
 
     def insert(self, *args):
         r"""
-        insert(vector_longinteger_t self, std::vector< unsigned long >::iterator pos, std::vector< unsigned long >::value_type const & x) -> std::vector< unsigned long >::iterator
-        insert(vector_longinteger_t self, std::vector< unsigned long >::iterator pos, std::vector< unsigned long >::size_type n, std::vector< unsigned long >::value_type const & x)
+        insert(vector_longinteger_T self, std::vector< unsigned long >::iterator pos, std::vector< unsigned long >::value_type const & x) -> std::vector< unsigned long >::iterator
+        insert(vector_longinteger_T self, std::vector< unsigned long >::iterator pos, std::vector< unsigned long >::size_type n, std::vector< unsigned long >::value_type const & x)
         """
-        return _libBornAgainSim.vector_longinteger_t_insert(self, *args)
+        return _libBornAgainSim.vector_longinteger_T_insert(self, *args)
 
     def reserve(self, n):
-        r"""reserve(vector_longinteger_t self, std::vector< unsigned long >::size_type n)"""
-        return _libBornAgainSim.vector_longinteger_t_reserve(self, n)
+        r"""reserve(vector_longinteger_T self, std::vector< unsigned long >::size_type n)"""
+        return _libBornAgainSim.vector_longinteger_T_reserve(self, n)
 
     def capacity(self):
-        r"""capacity(vector_longinteger_t self) -> std::vector< unsigned long >::size_type"""
-        return _libBornAgainSim.vector_longinteger_t_capacity(self)
-    __swig_destroy__ = _libBornAgainSim.delete_vector_longinteger_t
+        r"""capacity(vector_longinteger_T self) -> std::vector< unsigned long >::size_type"""
+        return _libBornAgainSim.vector_longinteger_T_capacity(self)
+    __swig_destroy__ = _libBornAgainSim.delete_vector_longinteger_T
 
-# Register vector_longinteger_t in _libBornAgainSim:
-_libBornAgainSim.vector_longinteger_t_swigregister(vector_longinteger_t)
-class vector_complex_t(object):
+# Register vector_longinteger_T in _libBornAgainSim:
+_libBornAgainSim.vector_longinteger_T_swigregister(vector_longinteger_T)
+class vector_complex_T(object):
     r"""Proxy of C++ std::vector< std::complex< double > > class."""
 
     thisown = property(lambda x: x.this.own(), lambda x, v: x.this.own(v), doc="The membership flag")
     __repr__ = _swig_repr
 
     def iterator(self):
-        r"""iterator(vector_complex_t self) -> SwigPyIterator"""
-        return _libBornAgainSim.vector_complex_t_iterator(self)
+        r"""iterator(vector_complex_T self) -> SwigPyIterator"""
+        return _libBornAgainSim.vector_complex_T_iterator(self)
     def __iter__(self):
         return self.iterator()
 
     def __nonzero__(self):
-        r"""__nonzero__(vector_complex_t self) -> bool"""
-        return _libBornAgainSim.vector_complex_t___nonzero__(self)
+        r"""__nonzero__(vector_complex_T self) -> bool"""
+        return _libBornAgainSim.vector_complex_T___nonzero__(self)
 
     def __bool__(self):
-        r"""__bool__(vector_complex_t self) -> bool"""
-        return _libBornAgainSim.vector_complex_t___bool__(self)
+        r"""__bool__(vector_complex_T self) -> bool"""
+        return _libBornAgainSim.vector_complex_T___bool__(self)
 
     def __len__(self):
-        r"""__len__(vector_complex_t self) -> std::vector< std::complex< double > >::size_type"""
-        return _libBornAgainSim.vector_complex_t___len__(self)
+        r"""__len__(vector_complex_T self) -> std::vector< std::complex< double > >::size_type"""
+        return _libBornAgainSim.vector_complex_T___len__(self)
 
     def __getslice__(self, i, j):
-        r"""__getslice__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j) -> vector_complex_t"""
-        return _libBornAgainSim.vector_complex_t___getslice__(self, i, j)
+        r"""__getslice__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j) -> vector_complex_T"""
+        return _libBornAgainSim.vector_complex_T___getslice__(self, i, j)
 
     def __setslice__(self, *args):
         r"""
-        __setslice__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j)
-        __setslice__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j, vector_complex_t v)
+        __setslice__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j)
+        __setslice__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j, vector_complex_T v)
         """
-        return _libBornAgainSim.vector_complex_t___setslice__(self, *args)
+        return _libBornAgainSim.vector_complex_T___setslice__(self, *args)
 
     def __delslice__(self, i, j):
-        r"""__delslice__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j)"""
-        return _libBornAgainSim.vector_complex_t___delslice__(self, i, j)
+        r"""__delslice__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j)"""
+        return _libBornAgainSim.vector_complex_T___delslice__(self, i, j)
 
     def __delitem__(self, *args):
         r"""
-        __delitem__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i)
-        __delitem__(vector_complex_t self, SWIGPY_SLICEOBJECT * slice)
+        __delitem__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i)
+        __delitem__(vector_complex_T self, SWIGPY_SLICEOBJECT * slice)
         """
-        return _libBornAgainSim.vector_complex_t___delitem__(self, *args)
+        return _libBornAgainSim.vector_complex_T___delitem__(self, *args)
 
     def __getitem__(self, *args):
         r"""
-        __getitem__(vector_complex_t self, SWIGPY_SLICEOBJECT * slice) -> vector_complex_t
-        __getitem__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i) -> std::vector< std::complex< double > >::value_type const &
+        __getitem__(vector_complex_T self, SWIGPY_SLICEOBJECT * slice) -> vector_complex_T
+        __getitem__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i) -> std::vector< std::complex< double > >::value_type const &
         """
-        return _libBornAgainSim.vector_complex_t___getitem__(self, *args)
+        return _libBornAgainSim.vector_complex_T___getitem__(self, *args)
 
     def __setitem__(self, *args):
         r"""
-        __setitem__(vector_complex_t self, SWIGPY_SLICEOBJECT * slice, vector_complex_t v)
-        __setitem__(vector_complex_t self, SWIGPY_SLICEOBJECT * slice)
-        __setitem__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::value_type const & x)
+        __setitem__(vector_complex_T self, SWIGPY_SLICEOBJECT * slice, vector_complex_T v)
+        __setitem__(vector_complex_T self, SWIGPY_SLICEOBJECT * slice)
+        __setitem__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::value_type const & x)
         """
-        return _libBornAgainSim.vector_complex_t___setitem__(self, *args)
+        return _libBornAgainSim.vector_complex_T___setitem__(self, *args)
 
     def pop(self):
-        r"""pop(vector_complex_t self) -> std::vector< std::complex< double > >::value_type"""
-        return _libBornAgainSim.vector_complex_t_pop(self)
+        r"""pop(vector_complex_T self) -> std::vector< std::complex< double > >::value_type"""
+        return _libBornAgainSim.vector_complex_T_pop(self)
 
     def append(self, x):
-        r"""append(vector_complex_t self, std::vector< std::complex< double > >::value_type const & x)"""
-        return _libBornAgainSim.vector_complex_t_append(self, x)
+        r"""append(vector_complex_T self, std::vector< std::complex< double > >::value_type const & x)"""
+        return _libBornAgainSim.vector_complex_T_append(self, x)
 
     def empty(self):
-        r"""empty(vector_complex_t self) -> bool"""
-        return _libBornAgainSim.vector_complex_t_empty(self)
+        r"""empty(vector_complex_T self) -> bool"""
+        return _libBornAgainSim.vector_complex_T_empty(self)
 
     def size(self):
-        r"""size(vector_complex_t self) -> std::vector< std::complex< double > >::size_type"""
-        return _libBornAgainSim.vector_complex_t_size(self)
+        r"""size(vector_complex_T self) -> std::vector< std::complex< double > >::size_type"""
+        return _libBornAgainSim.vector_complex_T_size(self)
 
     def swap(self, v):
-        r"""swap(vector_complex_t self, vector_complex_t v)"""
-        return _libBornAgainSim.vector_complex_t_swap(self, v)
+        r"""swap(vector_complex_T self, vector_complex_T v)"""
+        return _libBornAgainSim.vector_complex_T_swap(self, v)
 
     def begin(self):
-        r"""begin(vector_complex_t self) -> std::vector< std::complex< double > >::iterator"""
-        return _libBornAgainSim.vector_complex_t_begin(self)
+        r"""begin(vector_complex_T self) -> std::vector< std::complex< double > >::iterator"""
+        return _libBornAgainSim.vector_complex_T_begin(self)
 
     def end(self):
-        r"""end(vector_complex_t self) -> std::vector< std::complex< double > >::iterator"""
-        return _libBornAgainSim.vector_complex_t_end(self)
+        r"""end(vector_complex_T self) -> std::vector< std::complex< double > >::iterator"""
+        return _libBornAgainSim.vector_complex_T_end(self)
 
     def rbegin(self):
-        r"""rbegin(vector_complex_t self) -> std::vector< std::complex< double > >::reverse_iterator"""
-        return _libBornAgainSim.vector_complex_t_rbegin(self)
+        r"""rbegin(vector_complex_T self) -> std::vector< std::complex< double > >::reverse_iterator"""
+        return _libBornAgainSim.vector_complex_T_rbegin(self)
 
     def rend(self):
-        r"""rend(vector_complex_t self) -> std::vector< std::complex< double > >::reverse_iterator"""
-        return _libBornAgainSim.vector_complex_t_rend(self)
+        r"""rend(vector_complex_T self) -> std::vector< std::complex< double > >::reverse_iterator"""
+        return _libBornAgainSim.vector_complex_T_rend(self)
 
     def clear(self):
-        r"""clear(vector_complex_t self)"""
-        return _libBornAgainSim.vector_complex_t_clear(self)
+        r"""clear(vector_complex_T self)"""
+        return _libBornAgainSim.vector_complex_T_clear(self)
 
     def get_allocator(self):
-        r"""get_allocator(vector_complex_t self) -> std::vector< std::complex< double > >::allocator_type"""
-        return _libBornAgainSim.vector_complex_t_get_allocator(self)
+        r"""get_allocator(vector_complex_T self) -> std::vector< std::complex< double > >::allocator_type"""
+        return _libBornAgainSim.vector_complex_T_get_allocator(self)
 
     def pop_back(self):
-        r"""pop_back(vector_complex_t self)"""
-        return _libBornAgainSim.vector_complex_t_pop_back(self)
+        r"""pop_back(vector_complex_T self)"""
+        return _libBornAgainSim.vector_complex_T_pop_back(self)
 
     def erase(self, *args):
         r"""
-        erase(vector_complex_t self, std::vector< std::complex< double > >::iterator pos) -> std::vector< std::complex< double > >::iterator
-        erase(vector_complex_t self, std::vector< std::complex< double > >::iterator first, std::vector< std::complex< double > >::iterator last) -> std::vector< std::complex< double > >::iterator
+        erase(vector_complex_T self, std::vector< std::complex< double > >::iterator pos) -> std::vector< std::complex< double > >::iterator
+        erase(vector_complex_T self, std::vector< std::complex< double > >::iterator first, std::vector< std::complex< double > >::iterator last) -> std::vector< std::complex< double > >::iterator
         """
-        return _libBornAgainSim.vector_complex_t_erase(self, *args)
+        return _libBornAgainSim.vector_complex_T_erase(self, *args)
 
     def __init__(self, *args):
         r"""
-        __init__(vector_complex_t self) -> vector_complex_t
-        __init__(vector_complex_t self, vector_complex_t other) -> vector_complex_t
-        __init__(vector_complex_t self, std::vector< std::complex< double > >::size_type size) -> vector_complex_t
-        __init__(vector_complex_t self, std::vector< std::complex< double > >::size_type size, std::vector< std::complex< double > >::value_type const & value) -> vector_complex_t
+        __init__(vector_complex_T self) -> vector_complex_T
+        __init__(vector_complex_T self, vector_complex_T other) -> vector_complex_T
+        __init__(vector_complex_T self, std::vector< std::complex< double > >::size_type size) -> vector_complex_T
+        __init__(vector_complex_T self, std::vector< std::complex< double > >::size_type size, std::vector< std::complex< double > >::value_type const & value) -> vector_complex_T
         """
-        _libBornAgainSim.vector_complex_t_swiginit(self, _libBornAgainSim.new_vector_complex_t(*args))
+        _libBornAgainSim.vector_complex_T_swiginit(self, _libBornAgainSim.new_vector_complex_T(*args))
 
     def push_back(self, x):
-        r"""push_back(vector_complex_t self, std::vector< std::complex< double > >::value_type const & x)"""
-        return _libBornAgainSim.vector_complex_t_push_back(self, x)
+        r"""push_back(vector_complex_T self, std::vector< std::complex< double > >::value_type const & x)"""
+        return _libBornAgainSim.vector_complex_T_push_back(self, x)
 
     def front(self):
-        r"""front(vector_complex_t self) -> std::vector< std::complex< double > >::value_type const &"""
-        return _libBornAgainSim.vector_complex_t_front(self)
+        r"""front(vector_complex_T self) -> std::vector< std::complex< double > >::value_type const &"""
+        return _libBornAgainSim.vector_complex_T_front(self)
 
     def back(self):
-        r"""back(vector_complex_t self) -> std::vector< std::complex< double > >::value_type const &"""
-        return _libBornAgainSim.vector_complex_t_back(self)
+        r"""back(vector_complex_T self) -> std::vector< std::complex< double > >::value_type const &"""
+        return _libBornAgainSim.vector_complex_T_back(self)
 
     def assign(self, n, x):
-        r"""assign(vector_complex_t self, std::vector< std::complex< double > >::size_type n, std::vector< std::complex< double > >::value_type const & x)"""
-        return _libBornAgainSim.vector_complex_t_assign(self, n, x)
+        r"""assign(vector_complex_T self, std::vector< std::complex< double > >::size_type n, std::vector< std::complex< double > >::value_type const & x)"""
+        return _libBornAgainSim.vector_complex_T_assign(self, n, x)
 
     def resize(self, *args):
         r"""
-        resize(vector_complex_t self, std::vector< std::complex< double > >::size_type new_size)
-        resize(vector_complex_t self, std::vector< std::complex< double > >::size_type new_size, std::vector< std::complex< double > >::value_type const & x)
+        resize(vector_complex_T self, std::vector< std::complex< double > >::size_type new_size)
+        resize(vector_complex_T self, std::vector< std::complex< double > >::size_type new_size, std::vector< std::complex< double > >::value_type const & x)
         """
-        return _libBornAgainSim.vector_complex_t_resize(self, *args)
+        return _libBornAgainSim.vector_complex_T_resize(self, *args)
 
     def insert(self, *args):
         r"""
-        insert(vector_complex_t self, std::vector< std::complex< double > >::iterator pos, std::vector< std::complex< double > >::value_type const & x) -> std::vector< std::complex< double > >::iterator
-        insert(vector_complex_t self, std::vector< std::complex< double > >::iterator pos, std::vector< std::complex< double > >::size_type n, std::vector< std::complex< double > >::value_type const & x)
+        insert(vector_complex_T self, std::vector< std::complex< double > >::iterator pos, std::vector< std::complex< double > >::value_type const & x) -> std::vector< std::complex< double > >::iterator
+        insert(vector_complex_T self, std::vector< std::complex< double > >::iterator pos, std::vector< std::complex< double > >::size_type n, std::vector< std::complex< double > >::value_type const & x)
         """
-        return _libBornAgainSim.vector_complex_t_insert(self, *args)
+        return _libBornAgainSim.vector_complex_T_insert(self, *args)
 
     def reserve(self, n):
-        r"""reserve(vector_complex_t self, std::vector< std::complex< double > >::size_type n)"""
-        return _libBornAgainSim.vector_complex_t_reserve(self, n)
+        r"""reserve(vector_complex_T self, std::vector< std::complex< double > >::size_type n)"""
+        return _libBornAgainSim.vector_complex_T_reserve(self, n)
 
     def capacity(self):
-        r"""capacity(vector_complex_t self) -> std::vector< std::complex< double > >::size_type"""
-        return _libBornAgainSim.vector_complex_t_capacity(self)
-    __swig_destroy__ = _libBornAgainSim.delete_vector_complex_t
+        r"""capacity(vector_complex_T self) -> std::vector< std::complex< double > >::size_type"""
+        return _libBornAgainSim.vector_complex_T_capacity(self)
+    __swig_destroy__ = _libBornAgainSim.delete_vector_complex_T
 
-# Register vector_complex_t in _libBornAgainSim:
-_libBornAgainSim.vector_complex_t_swigregister(vector_complex_t)
-class vector_string_t(object):
+# Register vector_complex_T in _libBornAgainSim:
+_libBornAgainSim.vector_complex_T_swigregister(vector_complex_T)
+class vector_string_T(object):
     r"""Proxy of C++ std::vector< std::string > class."""
 
     thisown = property(lambda x: x.this.own(), lambda x, v: x.this.own(v), doc="The membership flag")
     __repr__ = _swig_repr
 
     def iterator(self):
-        r"""iterator(vector_string_t self) -> SwigPyIterator"""
-        return _libBornAgainSim.vector_string_t_iterator(self)
+        r"""iterator(vector_string_T self) -> SwigPyIterator"""
+        return _libBornAgainSim.vector_string_T_iterator(self)
     def __iter__(self):
         return self.iterator()
 
     def __nonzero__(self):
-        r"""__nonzero__(vector_string_t self) -> bool"""
-        return _libBornAgainSim.vector_string_t___nonzero__(self)
+        r"""__nonzero__(vector_string_T self) -> bool"""
+        return _libBornAgainSim.vector_string_T___nonzero__(self)
 
     def __bool__(self):
-        r"""__bool__(vector_string_t self) -> bool"""
-        return _libBornAgainSim.vector_string_t___bool__(self)
+        r"""__bool__(vector_string_T self) -> bool"""
+        return _libBornAgainSim.vector_string_T___bool__(self)
 
     def __len__(self):
-        r"""__len__(vector_string_t self) -> std::vector< std::string >::size_type"""
-        return _libBornAgainSim.vector_string_t___len__(self)
+        r"""__len__(vector_string_T self) -> std::vector< std::string >::size_type"""
+        return _libBornAgainSim.vector_string_T___len__(self)
 
     def __getslice__(self, i, j):
-        r"""__getslice__(vector_string_t self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j) -> vector_string_t"""
-        return _libBornAgainSim.vector_string_t___getslice__(self, i, j)
+        r"""__getslice__(vector_string_T self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j) -> vector_string_T"""
+        return _libBornAgainSim.vector_string_T___getslice__(self, i, j)
 
     def __setslice__(self, *args):
         r"""
-        __setslice__(vector_string_t self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j)
-        __setslice__(vector_string_t self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j, vector_string_t v)
+        __setslice__(vector_string_T self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j)
+        __setslice__(vector_string_T self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j, vector_string_T v)
         """
-        return _libBornAgainSim.vector_string_t___setslice__(self, *args)
+        return _libBornAgainSim.vector_string_T___setslice__(self, *args)
 
     def __delslice__(self, i, j):
-        r"""__delslice__(vector_string_t self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j)"""
-        return _libBornAgainSim.vector_string_t___delslice__(self, i, j)
+        r"""__delslice__(vector_string_T self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j)"""
+        return _libBornAgainSim.vector_string_T___delslice__(self, i, j)
 
     def __delitem__(self, *args):
         r"""
-        __delitem__(vector_string_t self, std::vector< std::string >::difference_type i)
-        __delitem__(vector_string_t self, SWIGPY_SLICEOBJECT * slice)
+        __delitem__(vector_string_T self, std::vector< std::string >::difference_type i)
+        __delitem__(vector_string_T self, SWIGPY_SLICEOBJECT * slice)
         """
-        return _libBornAgainSim.vector_string_t___delitem__(self, *args)
+        return _libBornAgainSim.vector_string_T___delitem__(self, *args)
 
     def __getitem__(self, *args):
         r"""
-        __getitem__(vector_string_t self, SWIGPY_SLICEOBJECT * slice) -> vector_string_t
-        __getitem__(vector_string_t self, std::vector< std::string >::difference_type i) -> std::vector< std::string >::value_type const &
+        __getitem__(vector_string_T self, SWIGPY_SLICEOBJECT * slice) -> vector_string_T
+        __getitem__(vector_string_T self, std::vector< std::string >::difference_type i) -> std::vector< std::string >::value_type const &
         """
-        return _libBornAgainSim.vector_string_t___getitem__(self, *args)
+        return _libBornAgainSim.vector_string_T___getitem__(self, *args)
 
     def __setitem__(self, *args):
         r"""
-        __setitem__(vector_string_t self, SWIGPY_SLICEOBJECT * slice, vector_string_t v)
-        __setitem__(vector_string_t self, SWIGPY_SLICEOBJECT * slice)
-        __setitem__(vector_string_t self, std::vector< std::string >::difference_type i, std::vector< std::string >::value_type const & x)
+        __setitem__(vector_string_T self, SWIGPY_SLICEOBJECT * slice, vector_string_T v)
+        __setitem__(vector_string_T self, SWIGPY_SLICEOBJECT * slice)
+        __setitem__(vector_string_T self, std::vector< std::string >::difference_type i, std::vector< std::string >::value_type const & x)
         """
-        return _libBornAgainSim.vector_string_t___setitem__(self, *args)
+        return _libBornAgainSim.vector_string_T___setitem__(self, *args)
 
     def pop(self):
-        r"""pop(vector_string_t self) -> std::vector< std::string >::value_type"""
-        return _libBornAgainSim.vector_string_t_pop(self)
+        r"""pop(vector_string_T self) -> std::vector< std::string >::value_type"""
+        return _libBornAgainSim.vector_string_T_pop(self)
 
     def append(self, x):
-        r"""append(vector_string_t self, std::vector< std::string >::value_type const & x)"""
-        return _libBornAgainSim.vector_string_t_append(self, x)
+        r"""append(vector_string_T self, std::vector< std::string >::value_type const & x)"""
+        return _libBornAgainSim.vector_string_T_append(self, x)
 
     def empty(self):
-        r"""empty(vector_string_t self) -> bool"""
-        return _libBornAgainSim.vector_string_t_empty(self)
+        r"""empty(vector_string_T self) -> bool"""
+        return _libBornAgainSim.vector_string_T_empty(self)
 
     def size(self):
-        r"""size(vector_string_t self) -> std::vector< std::string >::size_type"""
-        return _libBornAgainSim.vector_string_t_size(self)
+        r"""size(vector_string_T self) -> std::vector< std::string >::size_type"""
+        return _libBornAgainSim.vector_string_T_size(self)
 
     def swap(self, v):
-        r"""swap(vector_string_t self, vector_string_t v)"""
-        return _libBornAgainSim.vector_string_t_swap(self, v)
+        r"""swap(vector_string_T self, vector_string_T v)"""
+        return _libBornAgainSim.vector_string_T_swap(self, v)
 
     def begin(self):
-        r"""begin(vector_string_t self) -> std::vector< std::string >::iterator"""
-        return _libBornAgainSim.vector_string_t_begin(self)
+        r"""begin(vector_string_T self) -> std::vector< std::string >::iterator"""
+        return _libBornAgainSim.vector_string_T_begin(self)
 
     def end(self):
-        r"""end(vector_string_t self) -> std::vector< std::string >::iterator"""
-        return _libBornAgainSim.vector_string_t_end(self)
+        r"""end(vector_string_T self) -> std::vector< std::string >::iterator"""
+        return _libBornAgainSim.vector_string_T_end(self)
 
     def rbegin(self):
-        r"""rbegin(vector_string_t self) -> std::vector< std::string >::reverse_iterator"""
-        return _libBornAgainSim.vector_string_t_rbegin(self)
+        r"""rbegin(vector_string_T self) -> std::vector< std::string >::reverse_iterator"""
+        return _libBornAgainSim.vector_string_T_rbegin(self)
 
     def rend(self):
-        r"""rend(vector_string_t self) -> std::vector< std::string >::reverse_iterator"""
-        return _libBornAgainSim.vector_string_t_rend(self)
+        r"""rend(vector_string_T self) -> std::vector< std::string >::reverse_iterator"""
+        return _libBornAgainSim.vector_string_T_rend(self)
 
     def clear(self):
-        r"""clear(vector_string_t self)"""
-        return _libBornAgainSim.vector_string_t_clear(self)
+        r"""clear(vector_string_T self)"""
+        return _libBornAgainSim.vector_string_T_clear(self)
 
     def get_allocator(self):
-        r"""get_allocator(vector_string_t self) -> std::vector< std::string >::allocator_type"""
-        return _libBornAgainSim.vector_string_t_get_allocator(self)
+        r"""get_allocator(vector_string_T self) -> std::vector< std::string >::allocator_type"""
+        return _libBornAgainSim.vector_string_T_get_allocator(self)
 
     def pop_back(self):
-        r"""pop_back(vector_string_t self)"""
-        return _libBornAgainSim.vector_string_t_pop_back(self)
+        r"""pop_back(vector_string_T self)"""
+        return _libBornAgainSim.vector_string_T_pop_back(self)
 
     def erase(self, *args):
         r"""
-        erase(vector_string_t self, std::vector< std::string >::iterator pos) -> std::vector< std::string >::iterator
-        erase(vector_string_t self, std::vector< std::string >::iterator first, std::vector< std::string >::iterator last) -> std::vector< std::string >::iterator
+        erase(vector_string_T self, std::vector< std::string >::iterator pos) -> std::vector< std::string >::iterator
+        erase(vector_string_T self, std::vector< std::string >::iterator first, std::vector< std::string >::iterator last) -> std::vector< std::string >::iterator
         """
-        return _libBornAgainSim.vector_string_t_erase(self, *args)
+        return _libBornAgainSim.vector_string_T_erase(self, *args)
 
     def __init__(self, *args):
         r"""
-        __init__(vector_string_t self) -> vector_string_t
-        __init__(vector_string_t self, vector_string_t other) -> vector_string_t
-        __init__(vector_string_t self, std::vector< std::string >::size_type size) -> vector_string_t
-        __init__(vector_string_t self, std::vector< std::string >::size_type size, std::vector< std::string >::value_type const & value) -> vector_string_t
+        __init__(vector_string_T self) -> vector_string_T
+        __init__(vector_string_T self, vector_string_T other) -> vector_string_T
+        __init__(vector_string_T self, std::vector< std::string >::size_type size) -> vector_string_T
+        __init__(vector_string_T self, std::vector< std::string >::size_type size, std::vector< std::string >::value_type const & value) -> vector_string_T
         """
-        _libBornAgainSim.vector_string_t_swiginit(self, _libBornAgainSim.new_vector_string_t(*args))
+        _libBornAgainSim.vector_string_T_swiginit(self, _libBornAgainSim.new_vector_string_T(*args))
 
     def push_back(self, x):
-        r"""push_back(vector_string_t self, std::vector< std::string >::value_type const & x)"""
-        return _libBornAgainSim.vector_string_t_push_back(self, x)
+        r"""push_back(vector_string_T self, std::vector< std::string >::value_type const & x)"""
+        return _libBornAgainSim.vector_string_T_push_back(self, x)
 
     def front(self):
-        r"""front(vector_string_t self) -> std::vector< std::string >::value_type const &"""
-        return _libBornAgainSim.vector_string_t_front(self)
+        r"""front(vector_string_T self) -> std::vector< std::string >::value_type const &"""
+        return _libBornAgainSim.vector_string_T_front(self)
 
     def back(self):
-        r"""back(vector_string_t self) -> std::vector< std::string >::value_type const &"""
-        return _libBornAgainSim.vector_string_t_back(self)
+        r"""back(vector_string_T self) -> std::vector< std::string >::value_type const &"""
+        return _libBornAgainSim.vector_string_T_back(self)
 
     def assign(self, n, x):
-        r"""assign(vector_string_t self, std::vector< std::string >::size_type n, std::vector< std::string >::value_type const & x)"""
-        return _libBornAgainSim.vector_string_t_assign(self, n, x)
+        r"""assign(vector_string_T self, std::vector< std::string >::size_type n, std::vector< std::string >::value_type const & x)"""
+        return _libBornAgainSim.vector_string_T_assign(self, n, x)
 
     def resize(self, *args):
         r"""
-        resize(vector_string_t self, std::vector< std::string >::size_type new_size)
-        resize(vector_string_t self, std::vector< std::string >::size_type new_size, std::vector< std::string >::value_type const & x)
+        resize(vector_string_T self, std::vector< std::string >::size_type new_size)
+        resize(vector_string_T self, std::vector< std::string >::size_type new_size, std::vector< std::string >::value_type const & x)
         """
-        return _libBornAgainSim.vector_string_t_resize(self, *args)
+        return _libBornAgainSim.vector_string_T_resize(self, *args)
 
     def insert(self, *args):
         r"""
-        insert(vector_string_t self, std::vector< std::string >::iterator pos, std::vector< std::string >::value_type const & x) -> std::vector< std::string >::iterator
-        insert(vector_string_t self, std::vector< std::string >::iterator pos, std::vector< std::string >::size_type n, std::vector< std::string >::value_type const & x)
+        insert(vector_string_T self, std::vector< std::string >::iterator pos, std::vector< std::string >::value_type const & x) -> std::vector< std::string >::iterator
+        insert(vector_string_T self, std::vector< std::string >::iterator pos, std::vector< std::string >::size_type n, std::vector< std::string >::value_type const & x)
         """
-        return _libBornAgainSim.vector_string_t_insert(self, *args)
+        return _libBornAgainSim.vector_string_T_insert(self, *args)
 
     def reserve(self, n):
-        r"""reserve(vector_string_t self, std::vector< std::string >::size_type n)"""
-        return _libBornAgainSim.vector_string_t_reserve(self, n)
+        r"""reserve(vector_string_T self, std::vector< std::string >::size_type n)"""
+        return _libBornAgainSim.vector_string_T_reserve(self, n)
 
     def capacity(self):
-        r"""capacity(vector_string_t self) -> std::vector< std::string >::size_type"""
-        return _libBornAgainSim.vector_string_t_capacity(self)
-    __swig_destroy__ = _libBornAgainSim.delete_vector_string_t
+        r"""capacity(vector_string_T self) -> std::vector< std::string >::size_type"""
+        return _libBornAgainSim.vector_string_T_capacity(self)
+    __swig_destroy__ = _libBornAgainSim.delete_vector_string_T
 
-# Register vector_string_t in _libBornAgainSim:
-_libBornAgainSim.vector_string_t_swigregister(vector_string_t)
-class map_string_double_t(object):
+# Register vector_string_T in _libBornAgainSim:
+_libBornAgainSim.vector_string_T_swigregister(vector_string_T)
+class map_string_double_T(object):
     r"""Proxy of C++ std::map< std::string,double > class."""
 
     thisown = property(lambda x: x.this.own(), lambda x, v: x.this.own(v), doc="The membership flag")
     __repr__ = _swig_repr
 
     def iterator(self):
-        r"""iterator(map_string_double_t self) -> SwigPyIterator"""
-        return _libBornAgainSim.map_string_double_t_iterator(self)
+        r"""iterator(map_string_double_T self) -> SwigPyIterator"""
+        return _libBornAgainSim.map_string_double_T_iterator(self)
     def __iter__(self):
         return self.iterator()
 
     def __nonzero__(self):
-        r"""__nonzero__(map_string_double_t self) -> bool"""
-        return _libBornAgainSim.map_string_double_t___nonzero__(self)
+        r"""__nonzero__(map_string_double_T self) -> bool"""
+        return _libBornAgainSim.map_string_double_T___nonzero__(self)
 
     def __bool__(self):
-        r"""__bool__(map_string_double_t self) -> bool"""
-        return _libBornAgainSim.map_string_double_t___bool__(self)
+        r"""__bool__(map_string_double_T self) -> bool"""
+        return _libBornAgainSim.map_string_double_T___bool__(self)
 
     def __len__(self):
-        r"""__len__(map_string_double_t self) -> std::map< std::string,double >::size_type"""
-        return _libBornAgainSim.map_string_double_t___len__(self)
+        r"""__len__(map_string_double_T self) -> std::map< std::string,double >::size_type"""
+        return _libBornAgainSim.map_string_double_T___len__(self)
     def __iter__(self):
         return self.key_iterator()
     def iterkeys(self):
@@ -1348,124 +1348,124 @@ class map_string_double_t(object):
         return self.iterator()
 
     def __getitem__(self, key):
-        r"""__getitem__(map_string_double_t self, std::map< std::string,double >::key_type const & key) -> std::map< std::string,double >::mapped_type const &"""
-        return _libBornAgainSim.map_string_double_t___getitem__(self, key)
+        r"""__getitem__(map_string_double_T self, std::map< std::string,double >::key_type const & key) -> std::map< std::string,double >::mapped_type const &"""
+        return _libBornAgainSim.map_string_double_T___getitem__(self, key)
 
     def __delitem__(self, key):
-        r"""__delitem__(map_string_double_t self, std::map< std::string,double >::key_type const & key)"""
-        return _libBornAgainSim.map_string_double_t___delitem__(self, key)
+        r"""__delitem__(map_string_double_T self, std::map< std::string,double >::key_type const & key)"""
+        return _libBornAgainSim.map_string_double_T___delitem__(self, key)
 
     def has_key(self, key):
-        r"""has_key(map_string_double_t self, std::map< std::string,double >::key_type const & key) -> bool"""
-        return _libBornAgainSim.map_string_double_t_has_key(self, key)
+        r"""has_key(map_string_double_T self, std::map< std::string,double >::key_type const & key) -> bool"""
+        return _libBornAgainSim.map_string_double_T_has_key(self, key)
 
     def keys(self):
-        r"""keys(map_string_double_t self) -> PyObject *"""
-        return _libBornAgainSim.map_string_double_t_keys(self)
+        r"""keys(map_string_double_T self) -> PyObject *"""
+        return _libBornAgainSim.map_string_double_T_keys(self)
 
     def values(self):
-        r"""values(map_string_double_t self) -> PyObject *"""
-        return _libBornAgainSim.map_string_double_t_values(self)
+        r"""values(map_string_double_T self) -> PyObject *"""
+        return _libBornAgainSim.map_string_double_T_values(self)
 
     def items(self):
-        r"""items(map_string_double_t self) -> PyObject *"""
-        return _libBornAgainSim.map_string_double_t_items(self)
+        r"""items(map_string_double_T self) -> PyObject *"""
+        return _libBornAgainSim.map_string_double_T_items(self)
 
     def __contains__(self, key):
-        r"""__contains__(map_string_double_t self, std::map< std::string,double >::key_type const & key) -> bool"""
-        return _libBornAgainSim.map_string_double_t___contains__(self, key)
+        r"""__contains__(map_string_double_T self, std::map< std::string,double >::key_type const & key) -> bool"""
+        return _libBornAgainSim.map_string_double_T___contains__(self, key)
 
     def key_iterator(self):
-        r"""key_iterator(map_string_double_t self) -> SwigPyIterator"""
-        return _libBornAgainSim.map_string_double_t_key_iterator(self)
+        r"""key_iterator(map_string_double_T self) -> SwigPyIterator"""
+        return _libBornAgainSim.map_string_double_T_key_iterator(self)
 
     def value_iterator(self):
-        r"""value_iterator(map_string_double_t self) -> SwigPyIterator"""
-        return _libBornAgainSim.map_string_double_t_value_iterator(self)
+        r"""value_iterator(map_string_double_T self) -> SwigPyIterator"""
+        return _libBornAgainSim.map_string_double_T_value_iterator(self)
 
     def __setitem__(self, *args):
         r"""
-        __setitem__(map_string_double_t self, std::map< std::string,double >::key_type const & key)
-        __setitem__(map_string_double_t self, std::map< std::string,double >::key_type const & key, std::map< std::string,double >::mapped_type const & x)
+        __setitem__(map_string_double_T self, std::map< std::string,double >::key_type const & key)
+        __setitem__(map_string_double_T self, std::map< std::string,double >::key_type const & key, std::map< std::string,double >::mapped_type const & x)
         """
-        return _libBornAgainSim.map_string_double_t___setitem__(self, *args)
+        return _libBornAgainSim.map_string_double_T___setitem__(self, *args)
 
     def asdict(self):
-        r"""asdict(map_string_double_t self) -> PyObject *"""
-        return _libBornAgainSim.map_string_double_t_asdict(self)
+        r"""asdict(map_string_double_T self) -> PyObject *"""
+        return _libBornAgainSim.map_string_double_T_asdict(self)
 
     def __init__(self, *args):
         r"""
-        __init__(map_string_double_t self, std::less< std::string > const & other) -> map_string_double_t
-        __init__(map_string_double_t self) -> map_string_double_t
-        __init__(map_string_double_t self, map_string_double_t other) -> map_string_double_t
+        __init__(map_string_double_T self, std::less< std::string > const & other) -> map_string_double_T
+        __init__(map_string_double_T self) -> map_string_double_T
+        __init__(map_string_double_T self, map_string_double_T other) -> map_string_double_T
         """
-        _libBornAgainSim.map_string_double_t_swiginit(self, _libBornAgainSim.new_map_string_double_t(*args))
+        _libBornAgainSim.map_string_double_T_swiginit(self, _libBornAgainSim.new_map_string_double_T(*args))
 
     def empty(self):
-        r"""empty(map_string_double_t self) -> bool"""
-        return _libBornAgainSim.map_string_double_t_empty(self)
+        r"""empty(map_string_double_T self) -> bool"""
+        return _libBornAgainSim.map_string_double_T_empty(self)
 
     def size(self):
-        r"""size(map_string_double_t self) -> std::map< std::string,double >::size_type"""
-        return _libBornAgainSim.map_string_double_t_size(self)
+        r"""size(map_string_double_T self) -> std::map< std::string,double >::size_type"""
+        return _libBornAgainSim.map_string_double_T_size(self)
 
     def swap(self, v):
-        r"""swap(map_string_double_t self, map_string_double_t v)"""
-        return _libBornAgainSim.map_string_double_t_swap(self, v)
+        r"""swap(map_string_double_T self, map_string_double_T v)"""
+        return _libBornAgainSim.map_string_double_T_swap(self, v)
 
     def begin(self):
-        r"""begin(map_string_double_t self) -> std::map< std::string,double >::iterator"""
-        return _libBornAgainSim.map_string_double_t_begin(self)
+        r"""begin(map_string_double_T self) -> std::map< std::string,double >::iterator"""
+        return _libBornAgainSim.map_string_double_T_begin(self)
 
     def end(self):
-        r"""end(map_string_double_t self) -> std::map< std::string,double >::iterator"""
-        return _libBornAgainSim.map_string_double_t_end(self)
+        r"""end(map_string_double_T self) -> std::map< std::string,double >::iterator"""
+        return _libBornAgainSim.map_string_double_T_end(self)
 
     def rbegin(self):
-        r"""rbegin(map_string_double_t self) -> std::map< std::string,double >::reverse_iterator"""
-        return _libBornAgainSim.map_string_double_t_rbegin(self)
+        r"""rbegin(map_string_double_T self) -> std::map< std::string,double >::reverse_iterator"""
+        return _libBornAgainSim.map_string_double_T_rbegin(self)
 
     def rend(self):
-        r"""rend(map_string_double_t self) -> std::map< std::string,double >::reverse_iterator"""
-        return _libBornAgainSim.map_string_double_t_rend(self)
+        r"""rend(map_string_double_T self) -> std::map< std::string,double >::reverse_iterator"""
+        return _libBornAgainSim.map_string_double_T_rend(self)
 
     def clear(self):
-        r"""clear(map_string_double_t self)"""
-        return _libBornAgainSim.map_string_double_t_clear(self)
+        r"""clear(map_string_double_T self)"""
+        return _libBornAgainSim.map_string_double_T_clear(self)
 
     def get_allocator(self):
-        r"""get_allocator(map_string_double_t self) -> std::map< std::string,double >::allocator_type"""
-        return _libBornAgainSim.map_string_double_t_get_allocator(self)
+        r"""get_allocator(map_string_double_T self) -> std::map< std::string,double >::allocator_type"""
+        return _libBornAgainSim.map_string_double_T_get_allocator(self)
 
     def count(self, x):
-        r"""count(map_string_double_t self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::size_type"""
-        return _libBornAgainSim.map_string_double_t_count(self, x)
+        r"""count(map_string_double_T self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::size_type"""
+        return _libBornAgainSim.map_string_double_T_count(self, x)
 
     def erase(self, *args):
         r"""
-        erase(map_string_double_t self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::size_type
-        erase(map_string_double_t self, std::map< std::string,double >::iterator position)
-        erase(map_string_double_t self, std::map< std::string,double >::iterator first, std::map< std::string,double >::iterator last)
+        erase(map_string_double_T self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::size_type
+        erase(map_string_double_T self, std::map< std::string,double >::iterator position)
+        erase(map_string_double_T self, std::map< std::string,double >::iterator first, std::map< std::string,double >::iterator last)
         """
-        return _libBornAgainSim.map_string_double_t_erase(self, *args)
+        return _libBornAgainSim.map_string_double_T_erase(self, *args)
 
     def find(self, x):
-        r"""find(map_string_double_t self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"""
-        return _libBornAgainSim.map_string_double_t_find(self, x)
+        r"""find(map_string_double_T self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"""
+        return _libBornAgainSim.map_string_double_T_find(self, x)
 
     def lower_bound(self, x):
-        r"""lower_bound(map_string_double_t self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"""
-        return _libBornAgainSim.map_string_double_t_lower_bound(self, x)
+        r"""lower_bound(map_string_double_T self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"""
+        return _libBornAgainSim.map_string_double_T_lower_bound(self, x)
 
     def upper_bound(self, x):
-        r"""upper_bound(map_string_double_t self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"""
-        return _libBornAgainSim.map_string_double_t_upper_bound(self, x)
-    __swig_destroy__ = _libBornAgainSim.delete_map_string_double_t
+        r"""upper_bound(map_string_double_T self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"""
+        return _libBornAgainSim.map_string_double_T_upper_bound(self, x)
+    __swig_destroy__ = _libBornAgainSim.delete_map_string_double_T
 
-# Register map_string_double_t in _libBornAgainSim:
-_libBornAgainSim.map_string_double_t_swigregister(map_string_double_t)
-class pvacuum_double_t(object):
+# Register map_string_double_T in _libBornAgainSim:
+_libBornAgainSim.map_string_double_T_swigregister(map_string_double_T)
+class pvacuum_double_T(object):
     r"""Proxy of C++ std::pair< double,double > class."""
 
     thisown = property(lambda x: x.this.own(), lambda x, v: x.this.own(v), doc="The membership flag")
@@ -1473,13 +1473,13 @@ class pvacuum_double_t(object):
 
     def __init__(self, *args):
         r"""
-        __init__(pvacuum_double_t self) -> pvacuum_double_t
-        __init__(pvacuum_double_t self, double first, double second) -> pvacuum_double_t
-        __init__(pvacuum_double_t self, pvacuum_double_t other) -> pvacuum_double_t
+        __init__(pvacuum_double_T self) -> pvacuum_double_T
+        __init__(pvacuum_double_T self, double first, double second) -> pvacuum_double_T
+        __init__(pvacuum_double_T self, pvacuum_double_T other) -> pvacuum_double_T
         """
-        _libBornAgainSim.pvacuum_double_t_swiginit(self, _libBornAgainSim.new_pvacuum_double_t(*args))
-    first = property(_libBornAgainSim.pvacuum_double_t_first_get, _libBornAgainSim.pvacuum_double_t_first_set, doc=r"""first : double""")
-    second = property(_libBornAgainSim.pvacuum_double_t_second_get, _libBornAgainSim.pvacuum_double_t_second_set, doc=r"""second : double""")
+        _libBornAgainSim.pvacuum_double_T_swiginit(self, _libBornAgainSim.new_pvacuum_double_T(*args))
+    first = property(_libBornAgainSim.pvacuum_double_T_first_get, _libBornAgainSim.pvacuum_double_T_first_set, doc=r"""first : double""")
+    second = property(_libBornAgainSim.pvacuum_double_T_second_get, _libBornAgainSim.pvacuum_double_T_second_set, doc=r"""second : double""")
     def __len__(self):
         return 2
     def __repr__(self):
@@ -1494,176 +1494,176 @@ class pvacuum_double_t(object):
             self.first = val
         else:
             self.second = val
-    __swig_destroy__ = _libBornAgainSim.delete_pvacuum_double_t
+    __swig_destroy__ = _libBornAgainSim.delete_pvacuum_double_T
 
-# Register pvacuum_double_t in _libBornAgainSim:
-_libBornAgainSim.pvacuum_double_t_swigregister(pvacuum_double_t)
-class vector_pvacuum_double_t(object):
+# Register pvacuum_double_T in _libBornAgainSim:
+_libBornAgainSim.pvacuum_double_T_swigregister(pvacuum_double_T)
+class vector_pvacuum_double_T(object):
     r"""Proxy of C++ std::vector< std::pair< double,double > > class."""
 
     thisown = property(lambda x: x.this.own(), lambda x, v: x.this.own(v), doc="The membership flag")
     __repr__ = _swig_repr
 
     def iterator(self):
-        r"""iterator(vector_pvacuum_double_t self) -> SwigPyIterator"""
-        return _libBornAgainSim.vector_pvacuum_double_t_iterator(self)
+        r"""iterator(vector_pvacuum_double_T self) -> SwigPyIterator"""
+        return _libBornAgainSim.vector_pvacuum_double_T_iterator(self)
     def __iter__(self):
         return self.iterator()
 
     def __nonzero__(self):
-        r"""__nonzero__(vector_pvacuum_double_t self) -> bool"""
-        return _libBornAgainSim.vector_pvacuum_double_t___nonzero__(self)
+        r"""__nonzero__(vector_pvacuum_double_T self) -> bool"""
+        return _libBornAgainSim.vector_pvacuum_double_T___nonzero__(self)
 
     def __bool__(self):
-        r"""__bool__(vector_pvacuum_double_t self) -> bool"""
-        return _libBornAgainSim.vector_pvacuum_double_t___bool__(self)
+        r"""__bool__(vector_pvacuum_double_T self) -> bool"""
+        return _libBornAgainSim.vector_pvacuum_double_T___bool__(self)
 
     def __len__(self):
-        r"""__len__(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::size_type"""
-        return _libBornAgainSim.vector_pvacuum_double_t___len__(self)
+        r"""__len__(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::size_type"""
+        return _libBornAgainSim.vector_pvacuum_double_T___len__(self)
 
     def __getslice__(self, i, j):
-        r"""__getslice__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j) -> vector_pvacuum_double_t"""
-        return _libBornAgainSim.vector_pvacuum_double_t___getslice__(self, i, j)
+        r"""__getslice__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j) -> vector_pvacuum_double_T"""
+        return _libBornAgainSim.vector_pvacuum_double_T___getslice__(self, i, j)
 
     def __setslice__(self, *args):
         r"""
-        __setslice__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j)
-        __setslice__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j, vector_pvacuum_double_t v)
+        __setslice__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j)
+        __setslice__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j, vector_pvacuum_double_T v)
         """
-        return _libBornAgainSim.vector_pvacuum_double_t___setslice__(self, *args)
+        return _libBornAgainSim.vector_pvacuum_double_T___setslice__(self, *args)
 
     def __delslice__(self, i, j):
-        r"""__delslice__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j)"""
-        return _libBornAgainSim.vector_pvacuum_double_t___delslice__(self, i, j)
+        r"""__delslice__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j)"""
+        return _libBornAgainSim.vector_pvacuum_double_T___delslice__(self, i, j)
 
     def __delitem__(self, *args):
         r"""
-        __delitem__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i)
-        __delitem__(vector_pvacuum_double_t self, SWIGPY_SLICEOBJECT * slice)
+        __delitem__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i)
+        __delitem__(vector_pvacuum_double_T self, SWIGPY_SLICEOBJECT * slice)
         """
-        return _libBornAgainSim.vector_pvacuum_double_t___delitem__(self, *args)
+        return _libBornAgainSim.vector_pvacuum_double_T___delitem__(self, *args)
 
     def __getitem__(self, *args):
         r"""
-        __getitem__(vector_pvacuum_double_t self, SWIGPY_SLICEOBJECT * slice) -> vector_pvacuum_double_t
-        __getitem__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i) -> pvacuum_double_t
+        __getitem__(vector_pvacuum_double_T self, SWIGPY_SLICEOBJECT * slice) -> vector_pvacuum_double_T
+        __getitem__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i) -> pvacuum_double_T
         """
-        return _libBornAgainSim.vector_pvacuum_double_t___getitem__(self, *args)
+        return _libBornAgainSim.vector_pvacuum_double_T___getitem__(self, *args)
 
     def __setitem__(self, *args):
         r"""
-        __setitem__(vector_pvacuum_double_t self, SWIGPY_SLICEOBJECT * slice, vector_pvacuum_double_t v)
-        __setitem__(vector_pvacuum_double_t self, SWIGPY_SLICEOBJECT * slice)
-        __setitem__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i, pvacuum_double_t x)
+        __setitem__(vector_pvacuum_double_T self, SWIGPY_SLICEOBJECT * slice, vector_pvacuum_double_T v)
+        __setitem__(vector_pvacuum_double_T self, SWIGPY_SLICEOBJECT * slice)
+        __setitem__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i, pvacuum_double_T x)
         """
-        return _libBornAgainSim.vector_pvacuum_double_t___setitem__(self, *args)
+        return _libBornAgainSim.vector_pvacuum_double_T___setitem__(self, *args)
 
     def pop(self):
-        r"""pop(vector_pvacuum_double_t self) -> pvacuum_double_t"""
-        return _libBornAgainSim.vector_pvacuum_double_t_pop(self)
+        r"""pop(vector_pvacuum_double_T self) -> pvacuum_double_T"""
+        return _libBornAgainSim.vector_pvacuum_double_T_pop(self)
 
     def append(self, x):
-        r"""append(vector_pvacuum_double_t self, pvacuum_double_t x)"""
-        return _libBornAgainSim.vector_pvacuum_double_t_append(self, x)
+        r"""append(vector_pvacuum_double_T self, pvacuum_double_T x)"""
+        return _libBornAgainSim.vector_pvacuum_double_T_append(self, x)
 
     def empty(self):
-        r"""empty(vector_pvacuum_double_t self) -> bool"""
-        return _libBornAgainSim.vector_pvacuum_double_t_empty(self)
+        r"""empty(vector_pvacuum_double_T self) -> bool"""
+        return _libBornAgainSim.vector_pvacuum_double_T_empty(self)
 
     def size(self):
-        r"""size(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::size_type"""
-        return _libBornAgainSim.vector_pvacuum_double_t_size(self)
+        r"""size(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::size_type"""
+        return _libBornAgainSim.vector_pvacuum_double_T_size(self)
 
     def swap(self, v):
-        r"""swap(vector_pvacuum_double_t self, vector_pvacuum_double_t v)"""
-        return _libBornAgainSim.vector_pvacuum_double_t_swap(self, v)
+        r"""swap(vector_pvacuum_double_T self, vector_pvacuum_double_T v)"""
+        return _libBornAgainSim.vector_pvacuum_double_T_swap(self, v)
 
     def begin(self):
-        r"""begin(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::iterator"""
-        return _libBornAgainSim.vector_pvacuum_double_t_begin(self)
+        r"""begin(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::iterator"""
+        return _libBornAgainSim.vector_pvacuum_double_T_begin(self)
 
     def end(self):
-        r"""end(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::iterator"""
-        return _libBornAgainSim.vector_pvacuum_double_t_end(self)
+        r"""end(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::iterator"""
+        return _libBornAgainSim.vector_pvacuum_double_T_end(self)
 
     def rbegin(self):
-        r"""rbegin(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::reverse_iterator"""
-        return _libBornAgainSim.vector_pvacuum_double_t_rbegin(self)
+        r"""rbegin(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::reverse_iterator"""
+        return _libBornAgainSim.vector_pvacuum_double_T_rbegin(self)
 
     def rend(self):
-        r"""rend(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::reverse_iterator"""
-        return _libBornAgainSim.vector_pvacuum_double_t_rend(self)
+        r"""rend(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::reverse_iterator"""
+        return _libBornAgainSim.vector_pvacuum_double_T_rend(self)
 
     def clear(self):
-        r"""clear(vector_pvacuum_double_t self)"""
-        return _libBornAgainSim.vector_pvacuum_double_t_clear(self)
+        r"""clear(vector_pvacuum_double_T self)"""
+        return _libBornAgainSim.vector_pvacuum_double_T_clear(self)
 
     def get_allocator(self):
-        r"""get_allocator(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::allocator_type"""
-        return _libBornAgainSim.vector_pvacuum_double_t_get_allocator(self)
+        r"""get_allocator(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::allocator_type"""
+        return _libBornAgainSim.vector_pvacuum_double_T_get_allocator(self)
 
     def pop_back(self):
-        r"""pop_back(vector_pvacuum_double_t self)"""
-        return _libBornAgainSim.vector_pvacuum_double_t_pop_back(self)
+        r"""pop_back(vector_pvacuum_double_T self)"""
+        return _libBornAgainSim.vector_pvacuum_double_T_pop_back(self)
 
     def erase(self, *args):
         r"""
-        erase(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::iterator pos) -> std::vector< std::pair< double,double > >::iterator
-        erase(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::iterator first, std::vector< std::pair< double,double > >::iterator last) -> std::vector< std::pair< double,double > >::iterator
+        erase(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::iterator pos) -> std::vector< std::pair< double,double > >::iterator
+        erase(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::iterator first, std::vector< std::pair< double,double > >::iterator last) -> std::vector< std::pair< double,double > >::iterator
         """
-        return _libBornAgainSim.vector_pvacuum_double_t_erase(self, *args)
+        return _libBornAgainSim.vector_pvacuum_double_T_erase(self, *args)
 
     def __init__(self, *args):
         r"""
-        __init__(vector_pvacuum_double_t self) -> vector_pvacuum_double_t
-        __init__(vector_pvacuum_double_t self, vector_pvacuum_double_t other) -> vector_pvacuum_double_t
-        __init__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::size_type size) -> vector_pvacuum_double_t
-        __init__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::size_type size, pvacuum_double_t value) -> vector_pvacuum_double_t
+        __init__(vector_pvacuum_double_T self) -> vector_pvacuum_double_T
+        __init__(vector_pvacuum_double_T self, vector_pvacuum_double_T other) -> vector_pvacuum_double_T
+        __init__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::size_type size) -> vector_pvacuum_double_T
+        __init__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::size_type size, pvacuum_double_T value) -> vector_pvacuum_double_T
         """
-        _libBornAgainSim.vector_pvacuum_double_t_swiginit(self, _libBornAgainSim.new_vector_pvacuum_double_t(*args))
+        _libBornAgainSim.vector_pvacuum_double_T_swiginit(self, _libBornAgainSim.new_vector_pvacuum_double_T(*args))
 
     def push_back(self, x):
-        r"""push_back(vector_pvacuum_double_t self, pvacuum_double_t x)"""
-        return _libBornAgainSim.vector_pvacuum_double_t_push_back(self, x)
+        r"""push_back(vector_pvacuum_double_T self, pvacuum_double_T x)"""
+        return _libBornAgainSim.vector_pvacuum_double_T_push_back(self, x)
 
     def front(self):
-        r"""front(vector_pvacuum_double_t self) -> pvacuum_double_t"""
-        return _libBornAgainSim.vector_pvacuum_double_t_front(self)
+        r"""front(vector_pvacuum_double_T self) -> pvacuum_double_T"""
+        return _libBornAgainSim.vector_pvacuum_double_T_front(self)
 
     def back(self):
-        r"""back(vector_pvacuum_double_t self) -> pvacuum_double_t"""
-        return _libBornAgainSim.vector_pvacuum_double_t_back(self)
+        r"""back(vector_pvacuum_double_T self) -> pvacuum_double_T"""
+        return _libBornAgainSim.vector_pvacuum_double_T_back(self)
 
     def assign(self, n, x):
-        r"""assign(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::size_type n, pvacuum_double_t x)"""
-        return _libBornAgainSim.vector_pvacuum_double_t_assign(self, n, x)
+        r"""assign(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::size_type n, pvacuum_double_T x)"""
+        return _libBornAgainSim.vector_pvacuum_double_T_assign(self, n, x)
 
     def resize(self, *args):
         r"""
-        resize(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::size_type new_size)
-        resize(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::size_type new_size, pvacuum_double_t x)
+        resize(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::size_type new_size)
+        resize(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::size_type new_size, pvacuum_double_T x)
         """
-        return _libBornAgainSim.vector_pvacuum_double_t_resize(self, *args)
+        return _libBornAgainSim.vector_pvacuum_double_T_resize(self, *args)
 
     def insert(self, *args):
         r"""
-        insert(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::iterator pos, pvacuum_double_t x) -> std::vector< std::pair< double,double > >::iterator
-        insert(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::iterator pos, std::vector< std::pair< double,double > >::size_type n, pvacuum_double_t x)
+        insert(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::iterator pos, pvacuum_double_T x) -> std::vector< std::pair< double,double > >::iterator
+        insert(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::iterator pos, std::vector< std::pair< double,double > >::size_type n, pvacuum_double_T x)
         """
-        return _libBornAgainSim.vector_pvacuum_double_t_insert(self, *args)
+        return _libBornAgainSim.vector_pvacuum_double_T_insert(self, *args)
 
     def reserve(self, n):
-        r"""reserve(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::size_type n)"""
-        return _libBornAgainSim.vector_pvacuum_double_t_reserve(self, n)
+        r"""reserve(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::size_type n)"""
+        return _libBornAgainSim.vector_pvacuum_double_T_reserve(self, n)
 
     def capacity(self):
-        r"""capacity(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::size_type"""
-        return _libBornAgainSim.vector_pvacuum_double_t_capacity(self)
-    __swig_destroy__ = _libBornAgainSim.delete_vector_pvacuum_double_t
+        r"""capacity(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::size_type"""
+        return _libBornAgainSim.vector_pvacuum_double_T_capacity(self)
+    __swig_destroy__ = _libBornAgainSim.delete_vector_pvacuum_double_T
 
-# Register vector_pvacuum_double_t in _libBornAgainSim:
-_libBornAgainSim.vector_pvacuum_double_t_swigregister(vector_pvacuum_double_t)
+# Register vector_pvacuum_double_T in _libBornAgainSim:
+_libBornAgainSim.vector_pvacuum_double_T_swigregister(vector_pvacuum_double_T)
 import libBornAgainFit
 import libBornAgainBase
 class R3(object):
@@ -2260,7 +2260,7 @@ class IterationInfo(object):
         return _libBornAgainSim.IterationInfo_parameters(self)
 
     def parameterMap(self):
-        r"""parameterMap(IterationInfo self) -> map_string_double_t"""
+        r"""parameterMap(IterationInfo self) -> map_string_double_T"""
         return _libBornAgainSim.IterationInfo_parameterMap(self)
     __swig_destroy__ = _libBornAgainSim.delete_IterationInfo
 
@@ -2344,7 +2344,7 @@ class FitObjective(object):
         return _libBornAgainSim.FitObjective_evaluate_cpp(self, params)
 
     def evaluate_residuals_cpp(self, params):
-        r"""evaluate_residuals_cpp(FitObjective self, mumufit::Parameters const & params) -> vdouble1d_t"""
+        r"""evaluate_residuals_cpp(FitObjective self, mumufit::Parameters const & params) -> vdouble1d_T"""
         return _libBornAgainSim.FitObjective_evaluate_residuals_cpp(self, params)
 
     def simulationResult(self, i_item=0):
@@ -2364,11 +2364,11 @@ class FitObjective(object):
         return _libBornAgainSim.FitObjective_absoluteDifference(self, i_item)
 
     def flatExpData(self):
-        r"""flatExpData(FitObjective self) -> vdouble1d_t"""
+        r"""flatExpData(FitObjective self) -> vdouble1d_T"""
         return _libBornAgainSim.FitObjective_flatExpData(self)
 
     def flatSimData(self):
-        r"""flatSimData(FitObjective self) -> vdouble1d_t"""
+        r"""flatSimData(FitObjective self) -> vdouble1d_T"""
         return _libBornAgainSim.FitObjective_flatSimData(self)
 
     def initPrint(self, every_nth):
@@ -2570,7 +2570,7 @@ class AlphaScan(PhysicalScan):
     def __init__(self, *args):
         r"""
         __init__(AlphaScan self, Scale alpha_axis) -> AlphaScan
-        __init__(AlphaScan self, vdouble1d_t points) -> AlphaScan
+        __init__(AlphaScan self, vdouble1d_T points) -> AlphaScan
         __init__(AlphaScan self, int nbins, double alpha_i_min, double alpha_i_max) -> AlphaScan
         """
         _libBornAgainSim.AlphaScan_swiginit(self, _libBornAgainSim.new_AlphaScan(*args))
@@ -2599,7 +2599,7 @@ class LambdaScan(PhysicalScan):
     def __init__(self, *args):
         r"""
         __init__(LambdaScan self, Scale lambdaScale) -> LambdaScan
-        __init__(LambdaScan self, vdouble1d_t points) -> LambdaScan
+        __init__(LambdaScan self, vdouble1d_T points) -> LambdaScan
         __init__(LambdaScan self, int nbins, double lambda_min, double lambda_max) -> LambdaScan
         """
         _libBornAgainSim.LambdaScan_swiginit(self, _libBornAgainSim.new_LambdaScan(*args))
@@ -2623,7 +2623,7 @@ class QzScan(BeamScan):
 
     def __init__(self, *args):
         r"""
-        __init__(QzScan self, vdouble1d_t qs_nm) -> QzScan
+        __init__(QzScan self, vdouble1d_T qs_nm) -> QzScan
         __init__(QzScan self, Scale qs_nm) -> QzScan
         __init__(QzScan self, int nbins, double qz_min, double qz_max) -> QzScan
         """
@@ -2651,7 +2651,7 @@ class QzScan(BeamScan):
         return _libBornAgainSim.QzScan_setAbsoluteQResolution(self, distr, std_dev)
 
     def setVectorResolution(self, distr, std_devs):
-        r"""setVectorResolution(QzScan self, IDistribution1D const & distr, vdouble1d_t std_devs)"""
+        r"""setVectorResolution(QzScan self, IDistribution1D const & distr, vdouble1d_T std_devs)"""
         return _libBornAgainSim.QzScan_setVectorResolution(self, distr, std_devs)
 
     def setOffset(self, offset):
@@ -2803,7 +2803,7 @@ class ConstantBackground(IBackground):
 
     def __init__(self, *args):
         r"""
-        __init__(ConstantBackground self, vdouble1d_t P) -> ConstantBackground
+        __init__(ConstantBackground self, vdouble1d_T P) -> ConstantBackground
         __init__(ConstantBackground self, double background_value) -> ConstantBackground
         """
         _libBornAgainSim.ConstantBackground_swiginit(self, _libBornAgainSim.new_ConstantBackground(*args))
diff --git a/auto/Wrap/libBornAgainSim_wrap.cpp b/auto/Wrap/libBornAgainSim_wrap.cpp
index d32fb9857a388ec0f6437e163b7924b98079c647..96ffc33827d2cdea541d5bf823d3e5e97e21783f 100644
--- a/auto/Wrap/libBornAgainSim_wrap.cpp
+++ b/auto/Wrap/libBornAgainSim_wrap.cpp
@@ -8347,7 +8347,7 @@ SWIGINTERN PyObject *SwigPyIterator_swigregister(PyObject *SWIGUNUSEDPARM(self),
   return SWIG_Py_Void();
 }
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_iterator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_iterator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   PyObject **arg2 = (PyObject **) 0 ;
@@ -8362,7 +8362,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_iterator(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_iterator" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_iterator" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = (swig::SwigPyIterator *)std_vector_Sl_double_Sg__iterator(arg1,arg2);
@@ -8373,7 +8373,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___nonzero__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___nonzero__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -8386,7 +8386,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___nonzero__(PyObject *self, PyObject *arg
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___nonzero__" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___nonzero__" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = (bool)std_vector_Sl_double_Sg____nonzero__((std::vector< double > const *)arg1);
@@ -8397,7 +8397,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___bool__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___bool__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -8410,7 +8410,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___bool__(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___bool__" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___bool__" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = (bool)std_vector_Sl_double_Sg____bool__((std::vector< double > const *)arg1);
@@ -8421,7 +8421,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___len__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___len__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -8434,7 +8434,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___len__(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___len__" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___len__" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = std_vector_Sl_double_Sg____len__((std::vector< double > const *)arg1);
@@ -8445,7 +8445,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___getslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___getslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::difference_type arg2 ;
@@ -8460,20 +8460,20 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___getslice__(PyObject *self, PyObject *ar
   std::vector< double,std::allocator< double > > *result = 0 ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_t___getslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_T___getslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___getslice__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___getslice__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t___getslice__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T___getslice__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< double >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_t___getslice__" "', argument " "3"" of type '" "std::vector< double >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_T___getslice__" "', argument " "3"" of type '" "std::vector< double >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< double >::difference_type >(val3);
   try {
@@ -8490,7 +8490,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::difference_type arg2 ;
@@ -8506,17 +8506,17 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setslice____SWIG_0(PyObject *self, Py_s
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___setslice__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___setslice__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t___setslice__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T___setslice__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< double >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_t___setslice__" "', argument " "3"" of type '" "std::vector< double >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_T___setslice__" "', argument " "3"" of type '" "std::vector< double >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< double >::difference_type >(val3);
   try {
@@ -8533,7 +8533,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::difference_type arg2 ;
@@ -8551,27 +8551,27 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setslice____SWIG_1(PyObject *self, Py_s
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___setslice__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___setslice__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t___setslice__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T___setslice__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< double >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_t___setslice__" "', argument " "3"" of type '" "std::vector< double >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_T___setslice__" "', argument " "3"" of type '" "std::vector< double >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< double >::difference_type >(val3);
   {
     std::vector< double,std::allocator< double > > *ptr = (std::vector< double,std::allocator< double > > *)0;
     res4 = swig::asptr(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vdouble1d_t___setslice__" "', argument " "4"" of type '" "std::vector< double,std::allocator< double > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vdouble1d_T___setslice__" "', argument " "4"" of type '" "std::vector< double,std::allocator< double > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble1d_t___setslice__" "', argument " "4"" of type '" "std::vector< double,std::allocator< double > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble1d_T___setslice__" "', argument " "4"" of type '" "std::vector< double,std::allocator< double > > const &""'"); 
     }
     arg4 = ptr;
   }
@@ -8591,13 +8591,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___setslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___setslice__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_t___setslice__", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_T___setslice__", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -8614,7 +8614,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setslice__(PyObject *self, PyObject *ar
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vdouble1d_t___setslice____SWIG_0(self, argc, argv);
+          return _wrap_vdouble1d_T___setslice____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -8637,7 +8637,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setslice__(PyObject *self, PyObject *ar
           int res = swig::asptr(argv[3], (std::vector< double,std::allocator< double > >**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vdouble1d_t___setslice____SWIG_1(self, argc, argv);
+            return _wrap_vdouble1d_T___setslice____SWIG_1(self, argc, argv);
           }
         }
       }
@@ -8645,7 +8645,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setslice__(PyObject *self, PyObject *ar
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_t___setslice__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_T___setslice__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< double >::__setslice__(std::vector< double >::difference_type,std::vector< double >::difference_type)\n"
     "    std::vector< double >::__setslice__(std::vector< double >::difference_type,std::vector< double >::difference_type,std::vector< double,std::allocator< double > > const &)\n");
@@ -8653,7 +8653,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___delslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___delslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::difference_type arg2 ;
@@ -8667,20 +8667,20 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___delslice__(PyObject *self, PyObject *ar
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_t___delslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_T___delslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___delslice__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___delslice__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t___delslice__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T___delslice__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< double >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_t___delslice__" "', argument " "3"" of type '" "std::vector< double >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_T___delslice__" "', argument " "3"" of type '" "std::vector< double >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< double >::difference_type >(val3);
   try {
@@ -8697,7 +8697,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::difference_type arg2 ;
@@ -8710,12 +8710,12 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___delitem____SWIG_0(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___delitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___delitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t___delitem__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T___delitem__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< double >::difference_type >(val2);
   try {
@@ -8732,7 +8732,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -8744,12 +8744,12 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___getitem____SWIG_0(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___getitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___getitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -8767,7 +8767,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -8780,12 +8780,12 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setitem____SWIG_0(PyObject *self, Py_ss
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___setitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___setitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -8793,10 +8793,10 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setitem____SWIG_0(PyObject *self, Py_ss
     std::vector< double,std::allocator< double > > *ptr = (std::vector< double,std::allocator< double > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble1d_t___setitem__" "', argument " "3"" of type '" "std::vector< double,std::allocator< double > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble1d_T___setitem__" "', argument " "3"" of type '" "std::vector< double,std::allocator< double > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble1d_t___setitem__" "', argument " "3"" of type '" "std::vector< double,std::allocator< double > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble1d_T___setitem__" "', argument " "3"" of type '" "std::vector< double,std::allocator< double > > const &""'"); 
     }
     arg3 = ptr;
   }
@@ -8816,7 +8816,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -8827,12 +8827,12 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setitem____SWIG_1(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___setitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___setitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -8850,7 +8850,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -8861,12 +8861,12 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___delitem____SWIG_1(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___delitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___delitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -8884,13 +8884,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___delitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___delitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_t___delitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_T___delitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -8901,7 +8901,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___delitem__(PyObject *self, PyObject *arg
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vdouble1d_t___delitem____SWIG_1(self, argc, argv);
+        return _wrap_vdouble1d_T___delitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -8915,13 +8915,13 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___delitem__(PyObject *self, PyObject *arg
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vdouble1d_t___delitem____SWIG_0(self, argc, argv);
+        return _wrap_vdouble1d_T___delitem____SWIG_0(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_t___delitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_T___delitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< double >::__delitem__(std::vector< double >::difference_type)\n"
     "    std::vector< double >::__delitem__(SWIGPY_SLICEOBJECT *)\n");
@@ -8929,7 +8929,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::difference_type arg2 ;
@@ -8943,12 +8943,12 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___getitem____SWIG_1(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___getitem__" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___getitem__" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t___getitem__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T___getitem__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< double >::difference_type >(val2);
   try {
@@ -8964,13 +8964,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___getitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___getitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_t___getitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_T___getitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -8981,7 +8981,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___getitem__(PyObject *self, PyObject *arg
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vdouble1d_t___getitem____SWIG_0(self, argc, argv);
+        return _wrap_vdouble1d_T___getitem____SWIG_0(self, argc, argv);
       }
     }
   }
@@ -8995,13 +8995,13 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___getitem__(PyObject *self, PyObject *arg
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vdouble1d_t___getitem____SWIG_1(self, argc, argv);
+        return _wrap_vdouble1d_T___getitem____SWIG_1(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_t___getitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_T___getitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< double >::__getitem__(SWIGPY_SLICEOBJECT *)\n"
     "    std::vector< double >::__getitem__(std::vector< double >::difference_type) const\n");
@@ -9009,7 +9009,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::difference_type arg2 ;
@@ -9026,17 +9026,17 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setitem____SWIG_2(PyObject *self, Py_ss
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t___setitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T___setitem__" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t___setitem__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T___setitem__" "', argument " "2"" of type '" "std::vector< double >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< double >::difference_type >(val2);
   ecode3 = SWIG_AsVal_double(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_t___setitem__" "', argument " "3"" of type '" "std::vector< double >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_T___setitem__" "', argument " "3"" of type '" "std::vector< double >::value_type""'");
   } 
   temp3 = static_cast< std::vector< double >::value_type >(val3);
   arg3 = &temp3;
@@ -9052,13 +9052,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t___setitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T___setitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_t___setitem__", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_T___setitem__", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -9069,7 +9069,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setitem__(PyObject *self, PyObject *arg
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vdouble1d_t___setitem____SWIG_1(self, argc, argv);
+        return _wrap_vdouble1d_T___setitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -9085,7 +9085,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setitem__(PyObject *self, PyObject *arg
         int res = swig::asptr(argv[2], (std::vector< double,std::allocator< double > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vdouble1d_t___setitem____SWIG_0(self, argc, argv);
+          return _wrap_vdouble1d_T___setitem____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -9105,14 +9105,14 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t___setitem__(PyObject *self, PyObject *arg
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vdouble1d_t___setitem____SWIG_2(self, argc, argv);
+          return _wrap_vdouble1d_T___setitem____SWIG_2(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_t___setitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_T___setitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< double >::__setitem__(SWIGPY_SLICEOBJECT *,std::vector< double,std::allocator< double > > const &)\n"
     "    std::vector< double >::__setitem__(SWIGPY_SLICEOBJECT *)\n"
@@ -9121,7 +9121,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_pop(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_pop(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -9134,7 +9134,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_pop(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_pop" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_pop" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   try {
@@ -9149,7 +9149,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_append(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_append(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::value_type *arg2 = 0 ;
@@ -9161,15 +9161,15 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_append(PyObject *self, PyObject *args) {
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_t_append", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_T_append", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_append" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_append" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_double(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t_append" "', argument " "2"" of type '" "std::vector< double >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T_append" "', argument " "2"" of type '" "std::vector< double >::value_type""'");
   } 
   temp2 = static_cast< std::vector< double >::value_type >(val2);
   arg2 = &temp2;
@@ -9181,7 +9181,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vdouble1d_t__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
+SWIGINTERN PyObject *_wrap_new_vdouble1d_T__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
   PyObject *resultobj = 0;
   std::vector< double > *result = 0 ;
   
@@ -9195,7 +9195,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vdouble1d_t__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vdouble1d_T__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = 0 ;
   int res1 = SWIG_OLDOBJ ;
@@ -9207,10 +9207,10 @@ SWIGINTERN PyObject *_wrap_new_vdouble1d_t__SWIG_1(PyObject *self, Py_ssize_t no
     std::vector< double,std::allocator< double > > *ptr = (std::vector< double,std::allocator< double > > *)0;
     res1 = swig::asptr(swig_obj[0], &ptr);
     if (!SWIG_IsOK(res1)) {
-      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vdouble1d_t" "', argument " "1"" of type '" "std::vector< double > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vdouble1d_T" "', argument " "1"" of type '" "std::vector< double > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vdouble1d_t" "', argument " "1"" of type '" "std::vector< double > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vdouble1d_T" "', argument " "1"" of type '" "std::vector< double > const &""'"); 
     }
     arg1 = ptr;
   }
@@ -9224,7 +9224,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_empty(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_empty(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -9237,7 +9237,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_empty(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_empty" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_empty" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = (bool)((std::vector< double > const *)arg1)->empty();
@@ -9248,7 +9248,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_size(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_size(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -9261,7 +9261,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_size(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_size" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_size" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = ((std::vector< double > const *)arg1)->size();
@@ -9272,7 +9272,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_swap(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_swap(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double > *arg2 = 0 ;
@@ -9283,18 +9283,18 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_swap(PyObject *self, PyObject *args) {
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_t_swap", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_T_swap", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_swap" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_swap" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], &argp2, SWIGTYPE_p_std__vectorT_double_t,  0 );
   if (!SWIG_IsOK(res2)) {
-    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vdouble1d_t_swap" "', argument " "2"" of type '" "std::vector< double > &""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vdouble1d_T_swap" "', argument " "2"" of type '" "std::vector< double > &""'"); 
   }
   if (!argp2) {
-    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble1d_t_swap" "', argument " "2"" of type '" "std::vector< double > &""'"); 
+    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble1d_T_swap" "', argument " "2"" of type '" "std::vector< double > &""'"); 
   }
   arg2 = reinterpret_cast< std::vector< double > * >(argp2);
   (arg1)->swap(*arg2);
@@ -9305,7 +9305,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_begin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_begin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -9318,7 +9318,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_begin(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_begin" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_begin" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = (arg1)->begin();
@@ -9330,7 +9330,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_end(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_end(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -9343,7 +9343,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_end(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_end" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_end" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = (arg1)->end();
@@ -9355,7 +9355,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_rbegin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_rbegin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -9368,7 +9368,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_rbegin(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_rbegin" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_rbegin" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = (arg1)->rbegin();
@@ -9380,7 +9380,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_rend(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_rend(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -9393,7 +9393,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_rend(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_rend" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_rend" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = (arg1)->rend();
@@ -9405,7 +9405,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_clear(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_clear(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -9417,7 +9417,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_clear(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_clear" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_clear" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   (arg1)->clear();
@@ -9428,7 +9428,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_get_allocator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_get_allocator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -9441,7 +9441,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_get_allocator(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_get_allocator" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_get_allocator" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = ((std::vector< double > const *)arg1)->get_allocator();
@@ -9452,7 +9452,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vdouble1d_t__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vdouble1d_T__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double >::size_type arg1 ;
   size_t val1 ;
@@ -9463,7 +9463,7 @@ SWIGINTERN PyObject *_wrap_new_vdouble1d_t__SWIG_2(PyObject *self, Py_ssize_t no
   if ((nobjs < 1) || (nobjs > 1)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vdouble1d_t" "', argument " "1"" of type '" "std::vector< double >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vdouble1d_T" "', argument " "1"" of type '" "std::vector< double >::size_type""'");
   } 
   arg1 = static_cast< std::vector< double >::size_type >(val1);
   result = (std::vector< double > *)new std::vector< double >(arg1);
@@ -9474,7 +9474,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_pop_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_pop_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -9486,7 +9486,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_pop_back(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_pop_back" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_pop_back" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   (arg1)->pop_back();
@@ -9497,7 +9497,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::size_type arg2 ;
@@ -9510,12 +9510,12 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_resize__SWIG_0(PyObject *self, Py_ssize_t
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_resize" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_resize" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t_resize" "', argument " "2"" of type '" "std::vector< double >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T_resize" "', argument " "2"" of type '" "std::vector< double >::size_type""'");
   } 
   arg2 = static_cast< std::vector< double >::size_type >(val2);
   (arg1)->resize(arg2);
@@ -9526,7 +9526,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::iterator arg2 ;
@@ -9540,18 +9540,18 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_erase__SWIG_0(PyObject *self, Py_ssize_t
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_erase" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_erase" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t_erase" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T_erase" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< double >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< double >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t_erase" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T_erase" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
     }
   }
   result = std_vector_Sl_double_Sg__erase__SWIG_0(arg1,SWIG_STD_MOVE(arg2));
@@ -9563,7 +9563,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::iterator arg2 ;
@@ -9580,29 +9580,29 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_erase__SWIG_1(PyObject *self, Py_ssize_t
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_erase" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_erase" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t_erase" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T_erase" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< double >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< double >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t_erase" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T_erase" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
     }
   }
   res3 = SWIG_ConvertPtr(swig_obj[2], SWIG_as_voidptrptr(&iter3), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res3) || !iter3) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t_erase" "', argument " "3"" of type '" "std::vector< double >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T_erase" "', argument " "3"" of type '" "std::vector< double >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< double >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< double >::iterator > *>(iter3);
     if (iter_t) {
       arg3 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t_erase" "', argument " "3"" of type '" "std::vector< double >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T_erase" "', argument " "3"" of type '" "std::vector< double >::iterator""'");
     }
   }
   result = std_vector_Sl_double_Sg__erase__SWIG_1(arg1,SWIG_STD_MOVE(arg2),SWIG_STD_MOVE(arg3));
@@ -9614,13 +9614,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_erase(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_erase(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_t_erase", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_T_erase", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -9631,7 +9631,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_erase(PyObject *self, PyObject *args) {
       int res = SWIG_ConvertPtr(argv[1], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
       _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< double >::iterator > *>(iter) != 0));
       if (_v) {
-        return _wrap_vdouble1d_t_erase__SWIG_0(self, argc, argv);
+        return _wrap_vdouble1d_T_erase__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -9648,14 +9648,14 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_erase(PyObject *self, PyObject *args) {
         int res = SWIG_ConvertPtr(argv[2], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
         _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< double >::iterator > *>(iter) != 0));
         if (_v) {
-          return _wrap_vdouble1d_t_erase__SWIG_1(self, argc, argv);
+          return _wrap_vdouble1d_T_erase__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_t_erase'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_T_erase'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< double >::erase(std::vector< double >::iterator)\n"
     "    std::vector< double >::erase(std::vector< double >::iterator,std::vector< double >::iterator)\n");
@@ -9663,7 +9663,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vdouble1d_t__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vdouble1d_T__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double >::size_type arg1 ;
   std::vector< double >::value_type *arg2 = 0 ;
@@ -9678,12 +9678,12 @@ SWIGINTERN PyObject *_wrap_new_vdouble1d_t__SWIG_3(PyObject *self, Py_ssize_t no
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vdouble1d_t" "', argument " "1"" of type '" "std::vector< double >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vdouble1d_T" "', argument " "1"" of type '" "std::vector< double >::size_type""'");
   } 
   arg1 = static_cast< std::vector< double >::size_type >(val1);
   ecode2 = SWIG_AsVal_double(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "new_vdouble1d_t" "', argument " "2"" of type '" "std::vector< double >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "new_vdouble1d_T" "', argument " "2"" of type '" "std::vector< double >::value_type""'");
   } 
   temp2 = static_cast< std::vector< double >::value_type >(val2);
   arg2 = &temp2;
@@ -9695,16 +9695,16 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vdouble1d_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_new_vdouble1d_T(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vdouble1d_t", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vdouble1d_T", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 0) {
-    return _wrap_new_vdouble1d_t__SWIG_0(self, argc, argv);
+    return _wrap_new_vdouble1d_T__SWIG_0(self, argc, argv);
   }
   if (argc == 1) {
     int _v = 0;
@@ -9713,7 +9713,7 @@ SWIGINTERN PyObject *_wrap_new_vdouble1d_t(PyObject *self, PyObject *args) {
       _v = SWIG_CheckState(res);
     }
     if (_v) {
-      return _wrap_new_vdouble1d_t__SWIG_2(self, argc, argv);
+      return _wrap_new_vdouble1d_T__SWIG_2(self, argc, argv);
     }
   }
   if (argc == 1) {
@@ -9721,7 +9721,7 @@ SWIGINTERN PyObject *_wrap_new_vdouble1d_t(PyObject *self, PyObject *args) {
     int res = swig::asptr(argv[0], (std::vector< double,std::allocator< double > >**)(0));
     _v = SWIG_CheckState(res);
     if (_v) {
-      return _wrap_new_vdouble1d_t__SWIG_1(self, argc, argv);
+      return _wrap_new_vdouble1d_T__SWIG_1(self, argc, argv);
     }
   }
   if (argc == 2) {
@@ -9736,13 +9736,13 @@ SWIGINTERN PyObject *_wrap_new_vdouble1d_t(PyObject *self, PyObject *args) {
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_new_vdouble1d_t__SWIG_3(self, argc, argv);
+        return _wrap_new_vdouble1d_T__SWIG_3(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vdouble1d_t'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vdouble1d_T'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< double >::vector()\n"
     "    std::vector< double >::vector(std::vector< double > const &)\n"
@@ -9752,7 +9752,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_push_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_push_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::value_type *arg2 = 0 ;
@@ -9764,15 +9764,15 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_push_back(PyObject *self, PyObject *args)
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_t_push_back", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_T_push_back", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_push_back" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_push_back" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_double(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t_push_back" "', argument " "2"" of type '" "std::vector< double >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T_push_back" "', argument " "2"" of type '" "std::vector< double >::value_type""'");
   } 
   temp2 = static_cast< std::vector< double >::value_type >(val2);
   arg2 = &temp2;
@@ -9784,7 +9784,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_front(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_front(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -9797,7 +9797,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_front(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_front" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_front" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = (std::vector< double >::value_type *) &((std::vector< double > const *)arg1)->front();
@@ -9809,7 +9809,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -9822,7 +9822,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_back(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_back" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_back" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = (std::vector< double >::value_type *) &((std::vector< double > const *)arg1)->back();
@@ -9834,7 +9834,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_assign(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_assign(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::size_type arg2 ;
@@ -9849,20 +9849,20 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_assign(PyObject *self, PyObject *args) {
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_t_assign", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_T_assign", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_assign" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_assign" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t_assign" "', argument " "2"" of type '" "std::vector< double >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T_assign" "', argument " "2"" of type '" "std::vector< double >::size_type""'");
   } 
   arg2 = static_cast< std::vector< double >::size_type >(val2);
   ecode3 = SWIG_AsVal_double(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_t_assign" "', argument " "3"" of type '" "std::vector< double >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_T_assign" "', argument " "3"" of type '" "std::vector< double >::value_type""'");
   } 
   temp3 = static_cast< std::vector< double >::value_type >(val3);
   arg3 = &temp3;
@@ -9874,7 +9874,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::size_type arg2 ;
@@ -9891,17 +9891,17 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_resize__SWIG_1(PyObject *self, Py_ssize_t
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_resize" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_resize" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t_resize" "', argument " "2"" of type '" "std::vector< double >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T_resize" "', argument " "2"" of type '" "std::vector< double >::size_type""'");
   } 
   arg2 = static_cast< std::vector< double >::size_type >(val2);
   ecode3 = SWIG_AsVal_double(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_t_resize" "', argument " "3"" of type '" "std::vector< double >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_T_resize" "', argument " "3"" of type '" "std::vector< double >::value_type""'");
   } 
   temp3 = static_cast< std::vector< double >::value_type >(val3);
   arg3 = &temp3;
@@ -9913,13 +9913,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_resize(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_resize(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_t_resize", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_T_resize", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -9931,7 +9931,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_resize(PyObject *self, PyObject *args) {
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vdouble1d_t_resize__SWIG_0(self, argc, argv);
+        return _wrap_vdouble1d_T_resize__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -9950,14 +9950,14 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_resize(PyObject *self, PyObject *args) {
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vdouble1d_t_resize__SWIG_1(self, argc, argv);
+          return _wrap_vdouble1d_T_resize__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_t_resize'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_T_resize'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< double >::resize(std::vector< double >::size_type)\n"
     "    std::vector< double >::resize(std::vector< double >::size_type,std::vector< double >::value_type const &)\n");
@@ -9965,7 +9965,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::iterator arg2 ;
@@ -9983,23 +9983,23 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_insert__SWIG_0(PyObject *self, Py_ssize_t
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_insert" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_insert" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t_insert" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T_insert" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< double >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< double >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t_insert" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T_insert" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_double(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_t_insert" "', argument " "3"" of type '" "std::vector< double >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_T_insert" "', argument " "3"" of type '" "std::vector< double >::value_type""'");
   } 
   temp3 = static_cast< std::vector< double >::value_type >(val3);
   arg3 = &temp3;
@@ -10012,7 +10012,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::iterator arg2 ;
@@ -10032,28 +10032,28 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_insert__SWIG_1(PyObject *self, Py_ssize_t
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_insert" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_insert" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t_insert" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T_insert" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< double >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< double >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_t_insert" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble1d_T_insert" "', argument " "2"" of type '" "std::vector< double >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_size_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_t_insert" "', argument " "3"" of type '" "std::vector< double >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble1d_T_insert" "', argument " "3"" of type '" "std::vector< double >::size_type""'");
   } 
   arg3 = static_cast< std::vector< double >::size_type >(val3);
   ecode4 = SWIG_AsVal_double(swig_obj[3], &val4);
   if (!SWIG_IsOK(ecode4)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode4), "in method '" "vdouble1d_t_insert" "', argument " "4"" of type '" "std::vector< double >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode4), "in method '" "vdouble1d_T_insert" "', argument " "4"" of type '" "std::vector< double >::value_type""'");
   } 
   temp4 = static_cast< std::vector< double >::value_type >(val4);
   arg4 = &temp4;
@@ -10065,13 +10065,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_insert(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_insert(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_t_insert", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble1d_T_insert", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -10087,7 +10087,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_insert(PyObject *self, PyObject *args) {
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vdouble1d_t_insert__SWIG_0(self, argc, argv);
+          return _wrap_vdouble1d_T_insert__SWIG_0(self, argc, argv);
         }
       }
     }
@@ -10111,7 +10111,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_insert(PyObject *self, PyObject *args) {
             _v = SWIG_CheckState(res);
           }
           if (_v) {
-            return _wrap_vdouble1d_t_insert__SWIG_1(self, argc, argv);
+            return _wrap_vdouble1d_T_insert__SWIG_1(self, argc, argv);
           }
         }
       }
@@ -10119,7 +10119,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_insert(PyObject *self, PyObject *args) {
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_t_insert'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble1d_T_insert'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< double >::insert(std::vector< double >::iterator,std::vector< double >::value_type const &)\n"
     "    std::vector< double >::insert(std::vector< double >::iterator,std::vector< double >::size_type,std::vector< double >::value_type const &)\n");
@@ -10127,7 +10127,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_reserve(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_reserve(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   std::vector< double >::size_type arg2 ;
@@ -10138,15 +10138,15 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_reserve(PyObject *self, PyObject *args) {
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_t_reserve", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble1d_T_reserve", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_reserve" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_reserve" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_t_reserve" "', argument " "2"" of type '" "std::vector< double >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble1d_T_reserve" "', argument " "2"" of type '" "std::vector< double >::size_type""'");
   } 
   arg2 = static_cast< std::vector< double >::size_type >(val2);
   (arg1)->reserve(arg2);
@@ -10157,7 +10157,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble1d_t_capacity(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble1d_T_capacity(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -10170,7 +10170,7 @@ SWIGINTERN PyObject *_wrap_vdouble1d_t_capacity(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_t_capacity" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble1d_T_capacity" "', argument " "1"" of type '" "std::vector< double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   result = ((std::vector< double > const *)arg1)->capacity();
@@ -10181,7 +10181,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_delete_vdouble1d_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_delete_vdouble1d_T(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< double > *arg1 = (std::vector< double > *) 0 ;
   void *argp1 = 0 ;
@@ -10193,7 +10193,7 @@ SWIGINTERN PyObject *_wrap_delete_vdouble1d_t(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_double_t, SWIG_POINTER_DISOWN |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vdouble1d_t" "', argument " "1"" of type '" "std::vector< double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vdouble1d_T" "', argument " "1"" of type '" "std::vector< double > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< double > * >(argp1);
   {
@@ -10214,18 +10214,18 @@ fail:
 }
 
 
-SWIGINTERN PyObject *vdouble1d_t_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vdouble1d_T_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   PyObject *obj;
   if (!SWIG_Python_UnpackTuple(args, "swigregister", 1, 1, &obj)) return NULL;
   SWIG_TypeNewClientData(SWIGTYPE_p_std__vectorT_double_t, SWIG_NewClientData(obj));
   return SWIG_Py_Void();
 }
 
-SWIGINTERN PyObject *vdouble1d_t_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vdouble1d_T_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   return SWIG_Python_InitShadowInstance(args);
 }
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_iterator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_iterator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   PyObject **arg2 = (PyObject **) 0 ;
@@ -10240,7 +10240,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_iterator(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_iterator" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_iterator" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = (swig::SwigPyIterator *)std_vector_Sl_std_vector_Sl_double_Sg__Sg__iterator(arg1,arg2);
@@ -10251,7 +10251,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___nonzero__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___nonzero__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -10264,7 +10264,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___nonzero__(PyObject *self, PyObject *arg
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___nonzero__" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___nonzero__" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = (bool)std_vector_Sl_std_vector_Sl_double_Sg__Sg____nonzero__((std::vector< std::vector< double > > const *)arg1);
@@ -10275,7 +10275,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___bool__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___bool__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -10288,7 +10288,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___bool__(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___bool__" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___bool__" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = (bool)std_vector_Sl_std_vector_Sl_double_Sg__Sg____bool__((std::vector< std::vector< double > > const *)arg1);
@@ -10299,7 +10299,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___len__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___len__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -10312,7 +10312,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___len__(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___len__" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___len__" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = std_vector_Sl_std_vector_Sl_double_Sg__Sg____len__((std::vector< std::vector< double > > const *)arg1);
@@ -10323,7 +10323,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___getslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___getslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::difference_type arg2 ;
@@ -10338,20 +10338,20 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___getslice__(PyObject *self, PyObject *ar
   std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > *result = 0 ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_t___getslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_T___getslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___getslice__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___getslice__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_t___getslice__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_T___getslice__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble2d_t___getslice__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble2d_T___getslice__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::vector< double > >::difference_type >(val3);
   try {
@@ -10368,7 +10368,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::difference_type arg2 ;
@@ -10384,17 +10384,17 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setslice____SWIG_0(PyObject *self, Py_s
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___setslice__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___setslice__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_t___setslice__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_T___setslice__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble2d_t___setslice__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble2d_T___setslice__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::vector< double > >::difference_type >(val3);
   try {
@@ -10411,7 +10411,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::difference_type arg2 ;
@@ -10429,27 +10429,27 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setslice____SWIG_1(PyObject *self, Py_s
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___setslice__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___setslice__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_t___setslice__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_T___setslice__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble2d_t___setslice__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble2d_T___setslice__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::vector< double > >::difference_type >(val3);
   {
     std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > *ptr = (std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > *)0;
     res4 = swig::asptr(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vdouble2d_t___setslice__" "', argument " "4"" of type '" "std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vdouble2d_T___setslice__" "', argument " "4"" of type '" "std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_t___setslice__" "', argument " "4"" of type '" "std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_T___setslice__" "', argument " "4"" of type '" "std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > const &""'"); 
     }
     arg4 = ptr;
   }
@@ -10469,13 +10469,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___setslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___setslice__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_t___setslice__", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_T___setslice__", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -10492,7 +10492,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setslice__(PyObject *self, PyObject *ar
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vdouble2d_t___setslice____SWIG_0(self, argc, argv);
+          return _wrap_vdouble2d_T___setslice____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -10515,7 +10515,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setslice__(PyObject *self, PyObject *ar
           int res = swig::asptr(argv[3], (std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > >**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vdouble2d_t___setslice____SWIG_1(self, argc, argv);
+            return _wrap_vdouble2d_T___setslice____SWIG_1(self, argc, argv);
           }
         }
       }
@@ -10523,7 +10523,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setslice__(PyObject *self, PyObject *ar
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_t___setslice__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_T___setslice__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< double > >::__setslice__(std::vector< std::vector< double > >::difference_type,std::vector< std::vector< double > >::difference_type)\n"
     "    std::vector< std::vector< double > >::__setslice__(std::vector< std::vector< double > >::difference_type,std::vector< std::vector< double > >::difference_type,std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > const &)\n");
@@ -10531,7 +10531,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___delslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___delslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::difference_type arg2 ;
@@ -10545,20 +10545,20 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___delslice__(PyObject *self, PyObject *ar
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_t___delslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_T___delslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___delslice__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___delslice__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_t___delslice__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_T___delslice__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble2d_t___delslice__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble2d_T___delslice__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::vector< double > >::difference_type >(val3);
   try {
@@ -10575,7 +10575,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::difference_type arg2 ;
@@ -10588,12 +10588,12 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___delitem____SWIG_0(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___delitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___delitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_t___delitem__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_T___delitem__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< double > >::difference_type >(val2);
   try {
@@ -10610,7 +10610,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -10622,12 +10622,12 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___getitem____SWIG_0(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___getitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___getitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -10645,7 +10645,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -10658,12 +10658,12 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setitem____SWIG_0(PyObject *self, Py_ss
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -10671,10 +10671,10 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setitem____SWIG_0(PyObject *self, Py_ss
     std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > *ptr = (std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble2d_t___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble2d_T___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_t___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_T___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > const &""'"); 
     }
     arg3 = ptr;
   }
@@ -10694,7 +10694,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -10705,12 +10705,12 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setitem____SWIG_1(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -10728,7 +10728,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -10739,12 +10739,12 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___delitem____SWIG_1(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___delitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___delitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -10762,13 +10762,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___delitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___delitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_t___delitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_T___delitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -10779,7 +10779,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___delitem__(PyObject *self, PyObject *arg
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vdouble2d_t___delitem____SWIG_1(self, argc, argv);
+        return _wrap_vdouble2d_T___delitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -10793,13 +10793,13 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___delitem__(PyObject *self, PyObject *arg
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vdouble2d_t___delitem____SWIG_0(self, argc, argv);
+        return _wrap_vdouble2d_T___delitem____SWIG_0(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_t___delitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_T___delitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< double > >::__delitem__(std::vector< std::vector< double > >::difference_type)\n"
     "    std::vector< std::vector< double > >::__delitem__(SWIGPY_SLICEOBJECT *)\n");
@@ -10807,7 +10807,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::difference_type arg2 ;
@@ -10821,12 +10821,12 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___getitem____SWIG_1(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___getitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___getitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_t___getitem__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_T___getitem__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< double > >::difference_type >(val2);
   try {
@@ -10842,13 +10842,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___getitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___getitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_t___getitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_T___getitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -10859,7 +10859,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___getitem__(PyObject *self, PyObject *arg
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vdouble2d_t___getitem____SWIG_0(self, argc, argv);
+        return _wrap_vdouble2d_T___getitem____SWIG_0(self, argc, argv);
       }
     }
   }
@@ -10873,13 +10873,13 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___getitem__(PyObject *self, PyObject *arg
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vdouble2d_t___getitem____SWIG_1(self, argc, argv);
+        return _wrap_vdouble2d_T___getitem____SWIG_1(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_t___getitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_T___getitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< double > >::__getitem__(SWIGPY_SLICEOBJECT *)\n"
     "    std::vector< std::vector< double > >::__getitem__(std::vector< std::vector< double > >::difference_type) const\n");
@@ -10887,7 +10887,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::difference_type arg2 ;
@@ -10902,22 +10902,22 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setitem____SWIG_2(PyObject *self, Py_ss
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_t___setitem__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_T___setitem__" "', argument " "2"" of type '" "std::vector< std::vector< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< double > >::difference_type >(val2);
   {
     std::vector< double,std::allocator< double > > *ptr = (std::vector< double,std::allocator< double > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble2d_t___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble2d_T___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_t___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_T___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -10935,13 +10935,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t___setitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T___setitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_t___setitem__", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_T___setitem__", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -10952,7 +10952,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setitem__(PyObject *self, PyObject *arg
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vdouble2d_t___setitem____SWIG_1(self, argc, argv);
+        return _wrap_vdouble2d_T___setitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -10968,7 +10968,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setitem__(PyObject *self, PyObject *arg
         int res = swig::asptr(argv[2], (std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vdouble2d_t___setitem____SWIG_0(self, argc, argv);
+          return _wrap_vdouble2d_T___setitem____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -10986,14 +10986,14 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t___setitem__(PyObject *self, PyObject *arg
         int res = swig::asptr(argv[2], (std::vector< double,std::allocator< double > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vdouble2d_t___setitem____SWIG_2(self, argc, argv);
+          return _wrap_vdouble2d_T___setitem____SWIG_2(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_t___setitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_T___setitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< double > >::__setitem__(SWIGPY_SLICEOBJECT *,std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > const &)\n"
     "    std::vector< std::vector< double > >::__setitem__(SWIGPY_SLICEOBJECT *)\n"
@@ -11002,7 +11002,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_pop(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_pop(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -11015,7 +11015,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_pop(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_pop" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_pop" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   try {
@@ -11030,7 +11030,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_append(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_append(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::value_type *arg2 = 0 ;
@@ -11040,20 +11040,20 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_append(PyObject *self, PyObject *args) {
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_t_append", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_T_append", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_append" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_append" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   {
     std::vector< double,std::allocator< double > > *ptr = (std::vector< double,std::allocator< double > > *)0;
     res2 = swig::asptr(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vdouble2d_t_append" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vdouble2d_T_append" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_t_append" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_T_append" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -11067,7 +11067,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vdouble2d_t__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
+SWIGINTERN PyObject *_wrap_new_vdouble2d_T__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *result = 0 ;
   
@@ -11081,7 +11081,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vdouble2d_t__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vdouble2d_T__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double,std::allocator< double > > > *arg1 = 0 ;
   int res1 = SWIG_OLDOBJ ;
@@ -11093,10 +11093,10 @@ SWIGINTERN PyObject *_wrap_new_vdouble2d_t__SWIG_1(PyObject *self, Py_ssize_t no
     std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > *ptr = (std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > > *)0;
     res1 = swig::asptr(swig_obj[0], &ptr);
     if (!SWIG_IsOK(res1)) {
-      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vdouble2d_t" "', argument " "1"" of type '" "std::vector< std::vector< double,std::allocator< double > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vdouble2d_T" "', argument " "1"" of type '" "std::vector< std::vector< double,std::allocator< double > > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vdouble2d_t" "', argument " "1"" of type '" "std::vector< std::vector< double,std::allocator< double > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vdouble2d_T" "', argument " "1"" of type '" "std::vector< std::vector< double,std::allocator< double > > > const &""'"); 
     }
     arg1 = ptr;
   }
@@ -11110,7 +11110,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_empty(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_empty(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -11123,7 +11123,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_empty(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_empty" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_empty" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = (bool)((std::vector< std::vector< double > > const *)arg1)->empty();
@@ -11134,7 +11134,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_size(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_size(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -11147,7 +11147,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_size(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_size" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_size" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = ((std::vector< std::vector< double > > const *)arg1)->size();
@@ -11158,7 +11158,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_swap(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_swap(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double,std::allocator< double > > > *arg2 = 0 ;
@@ -11169,18 +11169,18 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_swap(PyObject *self, PyObject *args) {
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_t_swap", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_T_swap", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_swap" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_swap" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], &argp2, SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t,  0 );
   if (!SWIG_IsOK(res2)) {
-    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vdouble2d_t_swap" "', argument " "2"" of type '" "std::vector< std::vector< double,std::allocator< double > > > &""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vdouble2d_T_swap" "', argument " "2"" of type '" "std::vector< std::vector< double,std::allocator< double > > > &""'"); 
   }
   if (!argp2) {
-    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_t_swap" "', argument " "2"" of type '" "std::vector< std::vector< double,std::allocator< double > > > &""'"); 
+    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_T_swap" "', argument " "2"" of type '" "std::vector< std::vector< double,std::allocator< double > > > &""'"); 
   }
   arg2 = reinterpret_cast< std::vector< std::vector< double,std::allocator< double > > > * >(argp2);
   (arg1)->swap(*arg2);
@@ -11191,7 +11191,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_begin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_begin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -11204,7 +11204,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_begin(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_begin" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_begin" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = (arg1)->begin();
@@ -11216,7 +11216,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_end(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_end(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -11229,7 +11229,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_end(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_end" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_end" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = (arg1)->end();
@@ -11241,7 +11241,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_rbegin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_rbegin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -11254,7 +11254,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_rbegin(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_rbegin" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_rbegin" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = (arg1)->rbegin();
@@ -11266,7 +11266,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_rend(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_rend(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -11279,7 +11279,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_rend(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_rend" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_rend" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = (arg1)->rend();
@@ -11291,7 +11291,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_clear(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_clear(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -11303,7 +11303,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_clear(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_clear" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_clear" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   (arg1)->clear();
@@ -11314,7 +11314,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_get_allocator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_get_allocator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -11327,7 +11327,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_get_allocator(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_get_allocator" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_get_allocator" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = ((std::vector< std::vector< double > > const *)arg1)->get_allocator();
@@ -11338,7 +11338,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vdouble2d_t__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vdouble2d_T__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > >::size_type arg1 ;
   size_t val1 ;
@@ -11349,7 +11349,7 @@ SWIGINTERN PyObject *_wrap_new_vdouble2d_t__SWIG_2(PyObject *self, Py_ssize_t no
   if ((nobjs < 1) || (nobjs > 1)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vdouble2d_t" "', argument " "1"" of type '" "std::vector< std::vector< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vdouble2d_T" "', argument " "1"" of type '" "std::vector< std::vector< double > >::size_type""'");
   } 
   arg1 = static_cast< std::vector< std::vector< double > >::size_type >(val1);
   result = (std::vector< std::vector< double > > *)new std::vector< std::vector< double > >(arg1);
@@ -11360,7 +11360,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_pop_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_pop_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -11372,7 +11372,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_pop_back(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_pop_back" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_pop_back" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   (arg1)->pop_back();
@@ -11383,7 +11383,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::size_type arg2 ;
@@ -11396,12 +11396,12 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_resize__SWIG_0(PyObject *self, Py_ssize_t
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_resize" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_resize" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_t_resize" "', argument " "2"" of type '" "std::vector< std::vector< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_T_resize" "', argument " "2"" of type '" "std::vector< std::vector< double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< double > >::size_type >(val2);
   (arg1)->resize(arg2);
@@ -11412,7 +11412,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::iterator arg2 ;
@@ -11426,18 +11426,18 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_erase__SWIG_0(PyObject *self, Py_ssize_t
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_erase" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_erase" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t_erase" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T_erase" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t_erase" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T_erase" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
     }
   }
   result = std_vector_Sl_std_vector_Sl_double_Sg__Sg__erase__SWIG_0(arg1,SWIG_STD_MOVE(arg2));
@@ -11449,7 +11449,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::iterator arg2 ;
@@ -11466,29 +11466,29 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_erase__SWIG_1(PyObject *self, Py_ssize_t
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_erase" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_erase" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t_erase" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T_erase" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t_erase" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T_erase" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
     }
   }
   res3 = SWIG_ConvertPtr(swig_obj[2], SWIG_as_voidptrptr(&iter3), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res3) || !iter3) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t_erase" "', argument " "3"" of type '" "std::vector< std::vector< double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T_erase" "', argument " "3"" of type '" "std::vector< std::vector< double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *>(iter3);
     if (iter_t) {
       arg3 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t_erase" "', argument " "3"" of type '" "std::vector< std::vector< double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T_erase" "', argument " "3"" of type '" "std::vector< std::vector< double > >::iterator""'");
     }
   }
   result = std_vector_Sl_std_vector_Sl_double_Sg__Sg__erase__SWIG_1(arg1,SWIG_STD_MOVE(arg2),SWIG_STD_MOVE(arg3));
@@ -11500,13 +11500,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_erase(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_erase(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_t_erase", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_T_erase", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -11517,7 +11517,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_erase(PyObject *self, PyObject *args) {
       int res = SWIG_ConvertPtr(argv[1], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
       _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *>(iter) != 0));
       if (_v) {
-        return _wrap_vdouble2d_t_erase__SWIG_0(self, argc, argv);
+        return _wrap_vdouble2d_T_erase__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -11534,14 +11534,14 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_erase(PyObject *self, PyObject *args) {
         int res = SWIG_ConvertPtr(argv[2], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
         _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *>(iter) != 0));
         if (_v) {
-          return _wrap_vdouble2d_t_erase__SWIG_1(self, argc, argv);
+          return _wrap_vdouble2d_T_erase__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_t_erase'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_T_erase'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< double > >::erase(std::vector< std::vector< double > >::iterator)\n"
     "    std::vector< std::vector< double > >::erase(std::vector< std::vector< double > >::iterator,std::vector< std::vector< double > >::iterator)\n");
@@ -11549,7 +11549,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vdouble2d_t__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vdouble2d_T__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > >::size_type arg1 ;
   std::vector< std::vector< double > >::value_type *arg2 = 0 ;
@@ -11562,17 +11562,17 @@ SWIGINTERN PyObject *_wrap_new_vdouble2d_t__SWIG_3(PyObject *self, Py_ssize_t no
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vdouble2d_t" "', argument " "1"" of type '" "std::vector< std::vector< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vdouble2d_T" "', argument " "1"" of type '" "std::vector< std::vector< double > >::size_type""'");
   } 
   arg1 = static_cast< std::vector< std::vector< double > >::size_type >(val1);
   {
     std::vector< double,std::allocator< double > > *ptr = (std::vector< double,std::allocator< double > > *)0;
     res2 = swig::asptr(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "new_vdouble2d_t" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "new_vdouble2d_T" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vdouble2d_t" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vdouble2d_T" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -11586,16 +11586,16 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vdouble2d_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_new_vdouble2d_T(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vdouble2d_t", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vdouble2d_T", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 0) {
-    return _wrap_new_vdouble2d_t__SWIG_0(self, argc, argv);
+    return _wrap_new_vdouble2d_T__SWIG_0(self, argc, argv);
   }
   if (argc == 1) {
     int _v = 0;
@@ -11604,7 +11604,7 @@ SWIGINTERN PyObject *_wrap_new_vdouble2d_t(PyObject *self, PyObject *args) {
       _v = SWIG_CheckState(res);
     }
     if (_v) {
-      return _wrap_new_vdouble2d_t__SWIG_2(self, argc, argv);
+      return _wrap_new_vdouble2d_T__SWIG_2(self, argc, argv);
     }
   }
   if (argc == 1) {
@@ -11612,7 +11612,7 @@ SWIGINTERN PyObject *_wrap_new_vdouble2d_t(PyObject *self, PyObject *args) {
     int res = swig::asptr(argv[0], (std::vector< std::vector< double,std::allocator< double > >,std::allocator< std::vector< double,std::allocator< double > > > >**)(0));
     _v = SWIG_CheckState(res);
     if (_v) {
-      return _wrap_new_vdouble2d_t__SWIG_1(self, argc, argv);
+      return _wrap_new_vdouble2d_T__SWIG_1(self, argc, argv);
     }
   }
   if (argc == 2) {
@@ -11625,13 +11625,13 @@ SWIGINTERN PyObject *_wrap_new_vdouble2d_t(PyObject *self, PyObject *args) {
       int res = swig::asptr(argv[1], (std::vector< double,std::allocator< double > >**)(0));
       _v = SWIG_CheckState(res);
       if (_v) {
-        return _wrap_new_vdouble2d_t__SWIG_3(self, argc, argv);
+        return _wrap_new_vdouble2d_T__SWIG_3(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vdouble2d_t'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vdouble2d_T'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< double > >::vector()\n"
     "    std::vector< std::vector< double > >::vector(std::vector< std::vector< double,std::allocator< double > > > const &)\n"
@@ -11641,7 +11641,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_push_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_push_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::value_type *arg2 = 0 ;
@@ -11651,20 +11651,20 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_push_back(PyObject *self, PyObject *args)
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_t_push_back", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_T_push_back", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_push_back" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_push_back" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   {
     std::vector< double,std::allocator< double > > *ptr = (std::vector< double,std::allocator< double > > *)0;
     res2 = swig::asptr(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vdouble2d_t_push_back" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vdouble2d_T_push_back" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_t_push_back" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_T_push_back" "', argument " "2"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -11678,7 +11678,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_front(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_front(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -11691,7 +11691,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_front(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_front" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_front" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = (std::vector< std::vector< double > >::value_type *) &((std::vector< std::vector< double > > const *)arg1)->front();
@@ -11703,7 +11703,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -11716,7 +11716,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_back(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_back" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_back" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = (std::vector< std::vector< double > >::value_type *) &((std::vector< std::vector< double > > const *)arg1)->back();
@@ -11728,7 +11728,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_assign(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_assign(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::size_type arg2 ;
@@ -11741,25 +11741,25 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_assign(PyObject *self, PyObject *args) {
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_t_assign", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_T_assign", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_assign" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_assign" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_t_assign" "', argument " "2"" of type '" "std::vector< std::vector< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_T_assign" "', argument " "2"" of type '" "std::vector< std::vector< double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< double > >::size_type >(val2);
   {
     std::vector< double,std::allocator< double > > *ptr = (std::vector< double,std::allocator< double > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble2d_t_assign" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble2d_T_assign" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_t_assign" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_T_assign" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -11773,7 +11773,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::size_type arg2 ;
@@ -11788,22 +11788,22 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_resize__SWIG_1(PyObject *self, Py_ssize_t
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_resize" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_resize" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_t_resize" "', argument " "2"" of type '" "std::vector< std::vector< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_T_resize" "', argument " "2"" of type '" "std::vector< std::vector< double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< double > >::size_type >(val2);
   {
     std::vector< double,std::allocator< double > > *ptr = (std::vector< double,std::allocator< double > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble2d_t_resize" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble2d_T_resize" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_t_resize" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_T_resize" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -11817,13 +11817,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_resize(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_resize(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_t_resize", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_T_resize", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -11835,7 +11835,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_resize(PyObject *self, PyObject *args) {
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vdouble2d_t_resize__SWIG_0(self, argc, argv);
+        return _wrap_vdouble2d_T_resize__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -11852,14 +11852,14 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_resize(PyObject *self, PyObject *args) {
         int res = swig::asptr(argv[2], (std::vector< double,std::allocator< double > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vdouble2d_t_resize__SWIG_1(self, argc, argv);
+          return _wrap_vdouble2d_T_resize__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_t_resize'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_T_resize'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< double > >::resize(std::vector< std::vector< double > >::size_type)\n"
     "    std::vector< std::vector< double > >::resize(std::vector< std::vector< double > >::size_type,std::vector< std::vector< double > >::value_type const &)\n");
@@ -11867,7 +11867,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::iterator arg2 ;
@@ -11883,28 +11883,28 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_insert__SWIG_0(PyObject *self, Py_ssize_t
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_insert" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_insert" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t_insert" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T_insert" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t_insert" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T_insert" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
     }
   }
   {
     std::vector< double,std::allocator< double > > *ptr = (std::vector< double,std::allocator< double > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble2d_t_insert" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vdouble2d_T_insert" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_t_insert" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_T_insert" "', argument " "3"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -11919,7 +11919,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::iterator arg2 ;
@@ -11937,33 +11937,33 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_insert__SWIG_1(PyObject *self, Py_ssize_t
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_insert" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_insert" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t_insert" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T_insert" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_t_insert" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vdouble2d_T_insert" "', argument " "2"" of type '" "std::vector< std::vector< double > >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_size_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble2d_t_insert" "', argument " "3"" of type '" "std::vector< std::vector< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vdouble2d_T_insert" "', argument " "3"" of type '" "std::vector< std::vector< double > >::size_type""'");
   } 
   arg3 = static_cast< std::vector< std::vector< double > >::size_type >(val3);
   {
     std::vector< double,std::allocator< double > > *ptr = (std::vector< double,std::allocator< double > > *)0;
     res4 = swig::asptr(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vdouble2d_t_insert" "', argument " "4"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vdouble2d_T_insert" "', argument " "4"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_t_insert" "', argument " "4"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vdouble2d_T_insert" "', argument " "4"" of type '" "std::vector< std::vector< double > >::value_type const &""'"); 
     }
     arg4 = ptr;
   }
@@ -11977,13 +11977,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_insert(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_insert(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_t_insert", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vdouble2d_T_insert", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -11997,7 +11997,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_insert(PyObject *self, PyObject *args) {
         int res = swig::asptr(argv[2], (std::vector< double,std::allocator< double > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vdouble2d_t_insert__SWIG_0(self, argc, argv);
+          return _wrap_vdouble2d_T_insert__SWIG_0(self, argc, argv);
         }
       }
     }
@@ -12019,7 +12019,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_insert(PyObject *self, PyObject *args) {
           int res = swig::asptr(argv[3], (std::vector< double,std::allocator< double > >**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vdouble2d_t_insert__SWIG_1(self, argc, argv);
+            return _wrap_vdouble2d_T_insert__SWIG_1(self, argc, argv);
           }
         }
       }
@@ -12027,7 +12027,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_insert(PyObject *self, PyObject *args) {
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_t_insert'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vdouble2d_T_insert'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< double > >::insert(std::vector< std::vector< double > >::iterator,std::vector< std::vector< double > >::value_type const &)\n"
     "    std::vector< std::vector< double > >::insert(std::vector< std::vector< double > >::iterator,std::vector< std::vector< double > >::size_type,std::vector< std::vector< double > >::value_type const &)\n");
@@ -12035,7 +12035,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_reserve(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_reserve(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   std::vector< std::vector< double > >::size_type arg2 ;
@@ -12046,15 +12046,15 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_reserve(PyObject *self, PyObject *args) {
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_t_reserve", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vdouble2d_T_reserve", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_reserve" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_reserve" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_t_reserve" "', argument " "2"" of type '" "std::vector< std::vector< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vdouble2d_T_reserve" "', argument " "2"" of type '" "std::vector< std::vector< double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< double > >::size_type >(val2);
   (arg1)->reserve(arg2);
@@ -12065,7 +12065,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vdouble2d_t_capacity(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vdouble2d_T_capacity(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -12078,7 +12078,7 @@ SWIGINTERN PyObject *_wrap_vdouble2d_t_capacity(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_t_capacity" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vdouble2d_T_capacity" "', argument " "1"" of type '" "std::vector< std::vector< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   result = ((std::vector< std::vector< double > > const *)arg1)->capacity();
@@ -12089,7 +12089,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_delete_vdouble2d_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_delete_vdouble2d_T(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< double > > *arg1 = (std::vector< std::vector< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -12101,7 +12101,7 @@ SWIGINTERN PyObject *_wrap_delete_vdouble2d_t(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, SWIG_POINTER_DISOWN |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vdouble2d_t" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vdouble2d_T" "', argument " "1"" of type '" "std::vector< std::vector< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< double > > * >(argp1);
   {
@@ -12122,18 +12122,18 @@ fail:
 }
 
 
-SWIGINTERN PyObject *vdouble2d_t_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vdouble2d_T_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   PyObject *obj;
   if (!SWIG_Python_UnpackTuple(args, "swigregister", 1, 1, &obj)) return NULL;
   SWIG_TypeNewClientData(SWIGTYPE_p_std__vectorT_std__vectorT_double_t_t, SWIG_NewClientData(obj));
   return SWIG_Py_Void();
 }
 
-SWIGINTERN PyObject *vdouble2d_t_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vdouble2d_T_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   return SWIG_Python_InitShadowInstance(args);
 }
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_iterator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_iterator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   PyObject **arg2 = (PyObject **) 0 ;
@@ -12148,7 +12148,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_iterator(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_iterator" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_iterator" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = (swig::SwigPyIterator *)std_vector_Sl_int_Sg__iterator(arg1,arg2);
@@ -12159,7 +12159,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___nonzero__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___nonzero__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -12172,7 +12172,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___nonzero__(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___nonzero__" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___nonzero__" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = (bool)std_vector_Sl_int_Sg____nonzero__((std::vector< int > const *)arg1);
@@ -12183,7 +12183,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___bool__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___bool__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -12196,7 +12196,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___bool__(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___bool__" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___bool__" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = (bool)std_vector_Sl_int_Sg____bool__((std::vector< int > const *)arg1);
@@ -12207,7 +12207,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___len__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___len__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -12220,7 +12220,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___len__(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___len__" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___len__" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = std_vector_Sl_int_Sg____len__((std::vector< int > const *)arg1);
@@ -12231,7 +12231,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___getslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___getslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::difference_type arg2 ;
@@ -12246,20 +12246,20 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___getslice__(PyObject *self, PyObjec
   std::vector< int,std::allocator< int > > *result = 0 ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_integer_t___getslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_integer_T___getslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___getslice__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___getslice__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t___getslice__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T___getslice__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< int >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_t___getslice__" "', argument " "3"" of type '" "std::vector< int >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_T___getslice__" "', argument " "3"" of type '" "std::vector< int >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< int >::difference_type >(val3);
   try {
@@ -12276,7 +12276,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::difference_type arg2 ;
@@ -12292,17 +12292,17 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setslice____SWIG_0(PyObject *self,
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___setslice__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___setslice__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t___setslice__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T___setslice__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< int >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_t___setslice__" "', argument " "3"" of type '" "std::vector< int >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_T___setslice__" "', argument " "3"" of type '" "std::vector< int >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< int >::difference_type >(val3);
   try {
@@ -12319,7 +12319,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::difference_type arg2 ;
@@ -12337,27 +12337,27 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setslice____SWIG_1(PyObject *self,
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___setslice__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___setslice__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t___setslice__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T___setslice__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< int >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_t___setslice__" "', argument " "3"" of type '" "std::vector< int >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_T___setslice__" "', argument " "3"" of type '" "std::vector< int >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< int >::difference_type >(val3);
   {
     std::vector< int,std::allocator< int > > *ptr = (std::vector< int,std::allocator< int > > *)0;
     res4 = swig::asptr(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_integer_t___setslice__" "', argument " "4"" of type '" "std::vector< int,std::allocator< int > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_integer_T___setslice__" "', argument " "4"" of type '" "std::vector< int,std::allocator< int > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_integer_t___setslice__" "', argument " "4"" of type '" "std::vector< int,std::allocator< int > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_integer_T___setslice__" "', argument " "4"" of type '" "std::vector< int,std::allocator< int > > const &""'"); 
     }
     arg4 = ptr;
   }
@@ -12377,13 +12377,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___setslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___setslice__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_t___setslice__", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_T___setslice__", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -12400,7 +12400,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setslice__(PyObject *self, PyObjec
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_integer_t___setslice____SWIG_0(self, argc, argv);
+          return _wrap_vector_integer_T___setslice____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -12423,7 +12423,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setslice__(PyObject *self, PyObjec
           int res = swig::asptr(argv[3], (std::vector< int,std::allocator< int > >**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vector_integer_t___setslice____SWIG_1(self, argc, argv);
+            return _wrap_vector_integer_T___setslice____SWIG_1(self, argc, argv);
           }
         }
       }
@@ -12431,7 +12431,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setslice__(PyObject *self, PyObjec
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_t___setslice__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_T___setslice__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< int >::__setslice__(std::vector< int >::difference_type,std::vector< int >::difference_type)\n"
     "    std::vector< int >::__setslice__(std::vector< int >::difference_type,std::vector< int >::difference_type,std::vector< int,std::allocator< int > > const &)\n");
@@ -12439,7 +12439,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___delslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___delslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::difference_type arg2 ;
@@ -12453,20 +12453,20 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___delslice__(PyObject *self, PyObjec
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_integer_t___delslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_integer_T___delslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___delslice__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___delslice__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t___delslice__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T___delslice__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< int >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_t___delslice__" "', argument " "3"" of type '" "std::vector< int >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_T___delslice__" "', argument " "3"" of type '" "std::vector< int >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< int >::difference_type >(val3);
   try {
@@ -12483,7 +12483,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::difference_type arg2 ;
@@ -12496,12 +12496,12 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___delitem____SWIG_0(PyObject *self,
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___delitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___delitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t___delitem__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T___delitem__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< int >::difference_type >(val2);
   try {
@@ -12518,7 +12518,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -12530,12 +12530,12 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___getitem____SWIG_0(PyObject *self,
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___getitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___getitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -12553,7 +12553,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -12566,12 +12566,12 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setitem____SWIG_0(PyObject *self,
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___setitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___setitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -12579,10 +12579,10 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setitem____SWIG_0(PyObject *self,
     std::vector< int,std::allocator< int > > *ptr = (std::vector< int,std::allocator< int > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_integer_t___setitem__" "', argument " "3"" of type '" "std::vector< int,std::allocator< int > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_integer_T___setitem__" "', argument " "3"" of type '" "std::vector< int,std::allocator< int > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_integer_t___setitem__" "', argument " "3"" of type '" "std::vector< int,std::allocator< int > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_integer_T___setitem__" "', argument " "3"" of type '" "std::vector< int,std::allocator< int > > const &""'"); 
     }
     arg3 = ptr;
   }
@@ -12602,7 +12602,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -12613,12 +12613,12 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setitem____SWIG_1(PyObject *self,
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___setitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___setitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -12636,7 +12636,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -12647,12 +12647,12 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___delitem____SWIG_1(PyObject *self,
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___delitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___delitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -12670,13 +12670,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___delitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___delitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_t___delitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_T___delitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -12687,7 +12687,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___delitem__(PyObject *self, PyObject
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_integer_t___delitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_integer_T___delitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -12701,13 +12701,13 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___delitem__(PyObject *self, PyObject
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_integer_t___delitem____SWIG_0(self, argc, argv);
+        return _wrap_vector_integer_T___delitem____SWIG_0(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_t___delitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_T___delitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< int >::__delitem__(std::vector< int >::difference_type)\n"
     "    std::vector< int >::__delitem__(SWIGPY_SLICEOBJECT *)\n");
@@ -12715,7 +12715,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::difference_type arg2 ;
@@ -12729,12 +12729,12 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___getitem____SWIG_1(PyObject *self,
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___getitem__" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___getitem__" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t___getitem__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T___getitem__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< int >::difference_type >(val2);
   try {
@@ -12750,13 +12750,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___getitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___getitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_t___getitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_T___getitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -12767,7 +12767,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___getitem__(PyObject *self, PyObject
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_integer_t___getitem____SWIG_0(self, argc, argv);
+        return _wrap_vector_integer_T___getitem____SWIG_0(self, argc, argv);
       }
     }
   }
@@ -12781,13 +12781,13 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___getitem__(PyObject *self, PyObject
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_integer_t___getitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_integer_T___getitem____SWIG_1(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_t___getitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_T___getitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< int >::__getitem__(SWIGPY_SLICEOBJECT *)\n"
     "    std::vector< int >::__getitem__(std::vector< int >::difference_type) const\n");
@@ -12795,7 +12795,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::difference_type arg2 ;
@@ -12812,17 +12812,17 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setitem____SWIG_2(PyObject *self,
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t___setitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T___setitem__" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t___setitem__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T___setitem__" "', argument " "2"" of type '" "std::vector< int >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< int >::difference_type >(val2);
   ecode3 = SWIG_AsVal_int(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_t___setitem__" "', argument " "3"" of type '" "std::vector< int >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_T___setitem__" "', argument " "3"" of type '" "std::vector< int >::value_type""'");
   } 
   temp3 = static_cast< std::vector< int >::value_type >(val3);
   arg3 = &temp3;
@@ -12838,13 +12838,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t___setitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T___setitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_t___setitem__", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_T___setitem__", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -12855,7 +12855,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setitem__(PyObject *self, PyObject
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_integer_t___setitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_integer_T___setitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -12871,7 +12871,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setitem__(PyObject *self, PyObject
         int res = swig::asptr(argv[2], (std::vector< int,std::allocator< int > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vector_integer_t___setitem____SWIG_0(self, argc, argv);
+          return _wrap_vector_integer_T___setitem____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -12891,14 +12891,14 @@ SWIGINTERN PyObject *_wrap_vector_integer_t___setitem__(PyObject *self, PyObject
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_integer_t___setitem____SWIG_2(self, argc, argv);
+          return _wrap_vector_integer_T___setitem____SWIG_2(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_t___setitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_T___setitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< int >::__setitem__(SWIGPY_SLICEOBJECT *,std::vector< int,std::allocator< int > > const &)\n"
     "    std::vector< int >::__setitem__(SWIGPY_SLICEOBJECT *)\n"
@@ -12907,7 +12907,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_pop(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_pop(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -12920,7 +12920,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_pop(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_pop" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_pop" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   try {
@@ -12935,7 +12935,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_append(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_append(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::value_type *arg2 = 0 ;
@@ -12947,15 +12947,15 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_append(PyObject *self, PyObject *arg
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_integer_t_append", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_integer_T_append", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_append" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_append" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_int(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t_append" "', argument " "2"" of type '" "std::vector< int >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T_append" "', argument " "2"" of type '" "std::vector< int >::value_type""'");
   } 
   temp2 = static_cast< std::vector< int >::value_type >(val2);
   arg2 = &temp2;
@@ -12967,7 +12967,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_integer_t__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
+SWIGINTERN PyObject *_wrap_new_vector_integer_T__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
   PyObject *resultobj = 0;
   std::vector< int > *result = 0 ;
   
@@ -12981,7 +12981,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_integer_t__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_integer_T__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = 0 ;
   int res1 = SWIG_OLDOBJ ;
@@ -12993,10 +12993,10 @@ SWIGINTERN PyObject *_wrap_new_vector_integer_t__SWIG_1(PyObject *self, Py_ssize
     std::vector< int,std::allocator< int > > *ptr = (std::vector< int,std::allocator< int > > *)0;
     res1 = swig::asptr(swig_obj[0], &ptr);
     if (!SWIG_IsOK(res1)) {
-      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vector_integer_t" "', argument " "1"" of type '" "std::vector< int > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vector_integer_T" "', argument " "1"" of type '" "std::vector< int > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_integer_t" "', argument " "1"" of type '" "std::vector< int > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_integer_T" "', argument " "1"" of type '" "std::vector< int > const &""'"); 
     }
     arg1 = ptr;
   }
@@ -13010,7 +13010,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_empty(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_empty(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -13023,7 +13023,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_empty(PyObject *self, PyObject *args
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_empty" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_empty" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = (bool)((std::vector< int > const *)arg1)->empty();
@@ -13034,7 +13034,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_size(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_size(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -13047,7 +13047,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_size(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_size" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_size" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = ((std::vector< int > const *)arg1)->size();
@@ -13058,7 +13058,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_swap(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_swap(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int > *arg2 = 0 ;
@@ -13069,18 +13069,18 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_swap(PyObject *self, PyObject *args)
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_integer_t_swap", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_integer_T_swap", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_swap" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_swap" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], &argp2, SWIGTYPE_p_std__vectorT_int_t,  0 );
   if (!SWIG_IsOK(res2)) {
-    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_integer_t_swap" "', argument " "2"" of type '" "std::vector< int > &""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_integer_T_swap" "', argument " "2"" of type '" "std::vector< int > &""'"); 
   }
   if (!argp2) {
-    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_integer_t_swap" "', argument " "2"" of type '" "std::vector< int > &""'"); 
+    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_integer_T_swap" "', argument " "2"" of type '" "std::vector< int > &""'"); 
   }
   arg2 = reinterpret_cast< std::vector< int > * >(argp2);
   (arg1)->swap(*arg2);
@@ -13091,7 +13091,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_begin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_begin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -13104,7 +13104,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_begin(PyObject *self, PyObject *args
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_begin" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_begin" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = (arg1)->begin();
@@ -13116,7 +13116,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_end(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_end(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -13129,7 +13129,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_end(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_end" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_end" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = (arg1)->end();
@@ -13141,7 +13141,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_rbegin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_rbegin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -13154,7 +13154,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_rbegin(PyObject *self, PyObject *arg
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_rbegin" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_rbegin" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = (arg1)->rbegin();
@@ -13166,7 +13166,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_rend(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_rend(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -13179,7 +13179,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_rend(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_rend" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_rend" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = (arg1)->rend();
@@ -13191,7 +13191,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_clear(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_clear(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -13203,7 +13203,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_clear(PyObject *self, PyObject *args
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_clear" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_clear" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   (arg1)->clear();
@@ -13214,7 +13214,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_get_allocator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_get_allocator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -13227,7 +13227,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_get_allocator(PyObject *self, PyObje
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_get_allocator" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_get_allocator" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = ((std::vector< int > const *)arg1)->get_allocator();
@@ -13238,7 +13238,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_integer_t__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_integer_T__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int >::size_type arg1 ;
   size_t val1 ;
@@ -13249,7 +13249,7 @@ SWIGINTERN PyObject *_wrap_new_vector_integer_t__SWIG_2(PyObject *self, Py_ssize
   if ((nobjs < 1) || (nobjs > 1)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_integer_t" "', argument " "1"" of type '" "std::vector< int >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_integer_T" "', argument " "1"" of type '" "std::vector< int >::size_type""'");
   } 
   arg1 = static_cast< std::vector< int >::size_type >(val1);
   result = (std::vector< int > *)new std::vector< int >(arg1);
@@ -13260,7 +13260,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_pop_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_pop_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -13272,7 +13272,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_pop_back(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_pop_back" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_pop_back" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   (arg1)->pop_back();
@@ -13283,7 +13283,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::size_type arg2 ;
@@ -13296,12 +13296,12 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_resize__SWIG_0(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_resize" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_resize" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t_resize" "', argument " "2"" of type '" "std::vector< int >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T_resize" "', argument " "2"" of type '" "std::vector< int >::size_type""'");
   } 
   arg2 = static_cast< std::vector< int >::size_type >(val2);
   (arg1)->resize(arg2);
@@ -13312,7 +13312,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::iterator arg2 ;
@@ -13326,18 +13326,18 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_erase__SWIG_0(PyObject *self, Py_ssi
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_erase" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_erase" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t_erase" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T_erase" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< int >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< int >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t_erase" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T_erase" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
     }
   }
   result = std_vector_Sl_int_Sg__erase__SWIG_0(arg1,SWIG_STD_MOVE(arg2));
@@ -13349,7 +13349,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::iterator arg2 ;
@@ -13366,29 +13366,29 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_erase__SWIG_1(PyObject *self, Py_ssi
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_erase" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_erase" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t_erase" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T_erase" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< int >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< int >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t_erase" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T_erase" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
     }
   }
   res3 = SWIG_ConvertPtr(swig_obj[2], SWIG_as_voidptrptr(&iter3), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res3) || !iter3) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t_erase" "', argument " "3"" of type '" "std::vector< int >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T_erase" "', argument " "3"" of type '" "std::vector< int >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< int >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< int >::iterator > *>(iter3);
     if (iter_t) {
       arg3 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t_erase" "', argument " "3"" of type '" "std::vector< int >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T_erase" "', argument " "3"" of type '" "std::vector< int >::iterator""'");
     }
   }
   result = std_vector_Sl_int_Sg__erase__SWIG_1(arg1,SWIG_STD_MOVE(arg2),SWIG_STD_MOVE(arg3));
@@ -13400,13 +13400,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_erase(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_erase(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_t_erase", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_T_erase", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -13417,7 +13417,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_erase(PyObject *self, PyObject *args
       int res = SWIG_ConvertPtr(argv[1], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
       _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< int >::iterator > *>(iter) != 0));
       if (_v) {
-        return _wrap_vector_integer_t_erase__SWIG_0(self, argc, argv);
+        return _wrap_vector_integer_T_erase__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -13434,14 +13434,14 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_erase(PyObject *self, PyObject *args
         int res = SWIG_ConvertPtr(argv[2], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
         _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< int >::iterator > *>(iter) != 0));
         if (_v) {
-          return _wrap_vector_integer_t_erase__SWIG_1(self, argc, argv);
+          return _wrap_vector_integer_T_erase__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_t_erase'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_T_erase'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< int >::erase(std::vector< int >::iterator)\n"
     "    std::vector< int >::erase(std::vector< int >::iterator,std::vector< int >::iterator)\n");
@@ -13449,7 +13449,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_integer_t__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_integer_T__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int >::size_type arg1 ;
   std::vector< int >::value_type *arg2 = 0 ;
@@ -13464,12 +13464,12 @@ SWIGINTERN PyObject *_wrap_new_vector_integer_t__SWIG_3(PyObject *self, Py_ssize
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_integer_t" "', argument " "1"" of type '" "std::vector< int >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_integer_T" "', argument " "1"" of type '" "std::vector< int >::size_type""'");
   } 
   arg1 = static_cast< std::vector< int >::size_type >(val1);
   ecode2 = SWIG_AsVal_int(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "new_vector_integer_t" "', argument " "2"" of type '" "std::vector< int >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "new_vector_integer_T" "', argument " "2"" of type '" "std::vector< int >::value_type""'");
   } 
   temp2 = static_cast< std::vector< int >::value_type >(val2);
   arg2 = &temp2;
@@ -13481,16 +13481,16 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_integer_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_new_vector_integer_T(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vector_integer_t", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vector_integer_T", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 0) {
-    return _wrap_new_vector_integer_t__SWIG_0(self, argc, argv);
+    return _wrap_new_vector_integer_T__SWIG_0(self, argc, argv);
   }
   if (argc == 1) {
     int _v = 0;
@@ -13499,7 +13499,7 @@ SWIGINTERN PyObject *_wrap_new_vector_integer_t(PyObject *self, PyObject *args)
       _v = SWIG_CheckState(res);
     }
     if (_v) {
-      return _wrap_new_vector_integer_t__SWIG_2(self, argc, argv);
+      return _wrap_new_vector_integer_T__SWIG_2(self, argc, argv);
     }
   }
   if (argc == 1) {
@@ -13507,7 +13507,7 @@ SWIGINTERN PyObject *_wrap_new_vector_integer_t(PyObject *self, PyObject *args)
     int res = swig::asptr(argv[0], (std::vector< int,std::allocator< int > >**)(0));
     _v = SWIG_CheckState(res);
     if (_v) {
-      return _wrap_new_vector_integer_t__SWIG_1(self, argc, argv);
+      return _wrap_new_vector_integer_T__SWIG_1(self, argc, argv);
     }
   }
   if (argc == 2) {
@@ -13522,13 +13522,13 @@ SWIGINTERN PyObject *_wrap_new_vector_integer_t(PyObject *self, PyObject *args)
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_new_vector_integer_t__SWIG_3(self, argc, argv);
+        return _wrap_new_vector_integer_T__SWIG_3(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vector_integer_t'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vector_integer_T'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< int >::vector()\n"
     "    std::vector< int >::vector(std::vector< int > const &)\n"
@@ -13538,7 +13538,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_push_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_push_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::value_type *arg2 = 0 ;
@@ -13550,15 +13550,15 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_push_back(PyObject *self, PyObject *
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_integer_t_push_back", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_integer_T_push_back", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_push_back" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_push_back" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_int(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t_push_back" "', argument " "2"" of type '" "std::vector< int >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T_push_back" "', argument " "2"" of type '" "std::vector< int >::value_type""'");
   } 
   temp2 = static_cast< std::vector< int >::value_type >(val2);
   arg2 = &temp2;
@@ -13570,7 +13570,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_front(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_front(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -13583,7 +13583,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_front(PyObject *self, PyObject *args
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_front" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_front" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = (std::vector< int >::value_type *) &((std::vector< int > const *)arg1)->front();
@@ -13595,7 +13595,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -13608,7 +13608,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_back(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_back" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_back" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = (std::vector< int >::value_type *) &((std::vector< int > const *)arg1)->back();
@@ -13620,7 +13620,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_assign(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_assign(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::size_type arg2 ;
@@ -13635,20 +13635,20 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_assign(PyObject *self, PyObject *arg
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_integer_t_assign", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_integer_T_assign", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_assign" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_assign" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t_assign" "', argument " "2"" of type '" "std::vector< int >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T_assign" "', argument " "2"" of type '" "std::vector< int >::size_type""'");
   } 
   arg2 = static_cast< std::vector< int >::size_type >(val2);
   ecode3 = SWIG_AsVal_int(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_t_assign" "', argument " "3"" of type '" "std::vector< int >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_T_assign" "', argument " "3"" of type '" "std::vector< int >::value_type""'");
   } 
   temp3 = static_cast< std::vector< int >::value_type >(val3);
   arg3 = &temp3;
@@ -13660,7 +13660,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::size_type arg2 ;
@@ -13677,17 +13677,17 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_resize__SWIG_1(PyObject *self, Py_ss
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_resize" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_resize" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t_resize" "', argument " "2"" of type '" "std::vector< int >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T_resize" "', argument " "2"" of type '" "std::vector< int >::size_type""'");
   } 
   arg2 = static_cast< std::vector< int >::size_type >(val2);
   ecode3 = SWIG_AsVal_int(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_t_resize" "', argument " "3"" of type '" "std::vector< int >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_T_resize" "', argument " "3"" of type '" "std::vector< int >::value_type""'");
   } 
   temp3 = static_cast< std::vector< int >::value_type >(val3);
   arg3 = &temp3;
@@ -13699,13 +13699,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_resize(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_resize(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_t_resize", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_T_resize", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -13717,7 +13717,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_resize(PyObject *self, PyObject *arg
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_integer_t_resize__SWIG_0(self, argc, argv);
+        return _wrap_vector_integer_T_resize__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -13736,14 +13736,14 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_resize(PyObject *self, PyObject *arg
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_integer_t_resize__SWIG_1(self, argc, argv);
+          return _wrap_vector_integer_T_resize__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_t_resize'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_T_resize'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< int >::resize(std::vector< int >::size_type)\n"
     "    std::vector< int >::resize(std::vector< int >::size_type,std::vector< int >::value_type const &)\n");
@@ -13751,7 +13751,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::iterator arg2 ;
@@ -13769,23 +13769,23 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_insert__SWIG_0(PyObject *self, Py_ss
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_insert" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_insert" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t_insert" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T_insert" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< int >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< int >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t_insert" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T_insert" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_int(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_t_insert" "', argument " "3"" of type '" "std::vector< int >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_T_insert" "', argument " "3"" of type '" "std::vector< int >::value_type""'");
   } 
   temp3 = static_cast< std::vector< int >::value_type >(val3);
   arg3 = &temp3;
@@ -13798,7 +13798,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::iterator arg2 ;
@@ -13818,28 +13818,28 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_insert__SWIG_1(PyObject *self, Py_ss
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_insert" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_insert" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t_insert" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T_insert" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< int >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< int >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_t_insert" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_integer_T_insert" "', argument " "2"" of type '" "std::vector< int >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_size_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_t_insert" "', argument " "3"" of type '" "std::vector< int >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_integer_T_insert" "', argument " "3"" of type '" "std::vector< int >::size_type""'");
   } 
   arg3 = static_cast< std::vector< int >::size_type >(val3);
   ecode4 = SWIG_AsVal_int(swig_obj[3], &val4);
   if (!SWIG_IsOK(ecode4)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode4), "in method '" "vector_integer_t_insert" "', argument " "4"" of type '" "std::vector< int >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode4), "in method '" "vector_integer_T_insert" "', argument " "4"" of type '" "std::vector< int >::value_type""'");
   } 
   temp4 = static_cast< std::vector< int >::value_type >(val4);
   arg4 = &temp4;
@@ -13851,13 +13851,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_insert(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_insert(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_t_insert", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_integer_T_insert", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -13873,7 +13873,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_insert(PyObject *self, PyObject *arg
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_integer_t_insert__SWIG_0(self, argc, argv);
+          return _wrap_vector_integer_T_insert__SWIG_0(self, argc, argv);
         }
       }
     }
@@ -13897,7 +13897,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_insert(PyObject *self, PyObject *arg
             _v = SWIG_CheckState(res);
           }
           if (_v) {
-            return _wrap_vector_integer_t_insert__SWIG_1(self, argc, argv);
+            return _wrap_vector_integer_T_insert__SWIG_1(self, argc, argv);
           }
         }
       }
@@ -13905,7 +13905,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_insert(PyObject *self, PyObject *arg
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_t_insert'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_integer_T_insert'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< int >::insert(std::vector< int >::iterator,std::vector< int >::value_type const &)\n"
     "    std::vector< int >::insert(std::vector< int >::iterator,std::vector< int >::size_type,std::vector< int >::value_type const &)\n");
@@ -13913,7 +13913,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_reserve(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_reserve(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   std::vector< int >::size_type arg2 ;
@@ -13924,15 +13924,15 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_reserve(PyObject *self, PyObject *ar
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_integer_t_reserve", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_integer_T_reserve", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_reserve" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_reserve" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_t_reserve" "', argument " "2"" of type '" "std::vector< int >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_integer_T_reserve" "', argument " "2"" of type '" "std::vector< int >::size_type""'");
   } 
   arg2 = static_cast< std::vector< int >::size_type >(val2);
   (arg1)->reserve(arg2);
@@ -13943,7 +13943,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_integer_t_capacity(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_integer_T_capacity(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -13956,7 +13956,7 @@ SWIGINTERN PyObject *_wrap_vector_integer_t_capacity(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_t_capacity" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_integer_T_capacity" "', argument " "1"" of type '" "std::vector< int > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   result = ((std::vector< int > const *)arg1)->capacity();
@@ -13967,7 +13967,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_delete_vector_integer_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_delete_vector_integer_T(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< int > *arg1 = (std::vector< int > *) 0 ;
   void *argp1 = 0 ;
@@ -13979,7 +13979,7 @@ SWIGINTERN PyObject *_wrap_delete_vector_integer_t(PyObject *self, PyObject *arg
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_int_t, SWIG_POINTER_DISOWN |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vector_integer_t" "', argument " "1"" of type '" "std::vector< int > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vector_integer_T" "', argument " "1"" of type '" "std::vector< int > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< int > * >(argp1);
   {
@@ -14000,18 +14000,18 @@ fail:
 }
 
 
-SWIGINTERN PyObject *vector_integer_t_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vector_integer_T_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   PyObject *obj;
   if (!SWIG_Python_UnpackTuple(args, "swigregister", 1, 1, &obj)) return NULL;
   SWIG_TypeNewClientData(SWIGTYPE_p_std__vectorT_int_t, SWIG_NewClientData(obj));
   return SWIG_Py_Void();
 }
 
-SWIGINTERN PyObject *vector_integer_t_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vector_integer_T_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   return SWIG_Python_InitShadowInstance(args);
 }
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_iterator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_iterator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   PyObject **arg2 = (PyObject **) 0 ;
@@ -14026,7 +14026,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_iterator(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_iterator" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_iterator" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = (swig::SwigPyIterator *)std_vector_Sl_std_vector_Sl_int_Sg__Sg__iterator(arg1,arg2);
@@ -14037,7 +14037,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___nonzero__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___nonzero__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -14050,7 +14050,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___nonzero__(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___nonzero__" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___nonzero__" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = (bool)std_vector_Sl_std_vector_Sl_int_Sg__Sg____nonzero__((std::vector< std::vector< int > > const *)arg1);
@@ -14061,7 +14061,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___bool__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___bool__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -14074,7 +14074,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___bool__(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___bool__" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___bool__" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = (bool)std_vector_Sl_std_vector_Sl_int_Sg__Sg____bool__((std::vector< std::vector< int > > const *)arg1);
@@ -14085,7 +14085,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___len__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___len__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -14098,7 +14098,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___len__(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___len__" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___len__" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = std_vector_Sl_std_vector_Sl_int_Sg__Sg____len__((std::vector< std::vector< int > > const *)arg1);
@@ -14109,7 +14109,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___getslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___getslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::difference_type arg2 ;
@@ -14124,20 +14124,20 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___getslice__(PyObject *self, PyObject *a
   std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > *result = 0 ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_t___getslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_T___getslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___getslice__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___getslice__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_t___getslice__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_T___getslice__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< int > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vinteger2d_t___getslice__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vinteger2d_T___getslice__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::vector< int > >::difference_type >(val3);
   try {
@@ -14154,7 +14154,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::difference_type arg2 ;
@@ -14170,17 +14170,17 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setslice____SWIG_0(PyObject *self, Py_
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___setslice__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___setslice__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_t___setslice__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_T___setslice__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< int > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vinteger2d_t___setslice__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vinteger2d_T___setslice__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::vector< int > >::difference_type >(val3);
   try {
@@ -14197,7 +14197,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::difference_type arg2 ;
@@ -14215,27 +14215,27 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setslice____SWIG_1(PyObject *self, Py_
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___setslice__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___setslice__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_t___setslice__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_T___setslice__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< int > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vinteger2d_t___setslice__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vinteger2d_T___setslice__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::vector< int > >::difference_type >(val3);
   {
     std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > *ptr = (std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > *)0;
     res4 = swig::asptr(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vinteger2d_t___setslice__" "', argument " "4"" of type '" "std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vinteger2d_T___setslice__" "', argument " "4"" of type '" "std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_t___setslice__" "', argument " "4"" of type '" "std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_T___setslice__" "', argument " "4"" of type '" "std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > const &""'"); 
     }
     arg4 = ptr;
   }
@@ -14255,13 +14255,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___setslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___setslice__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_t___setslice__", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_T___setslice__", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -14278,7 +14278,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setslice__(PyObject *self, PyObject *a
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vinteger2d_t___setslice____SWIG_0(self, argc, argv);
+          return _wrap_vinteger2d_T___setslice____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -14301,7 +14301,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setslice__(PyObject *self, PyObject *a
           int res = swig::asptr(argv[3], (std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > >**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vinteger2d_t___setslice____SWIG_1(self, argc, argv);
+            return _wrap_vinteger2d_T___setslice____SWIG_1(self, argc, argv);
           }
         }
       }
@@ -14309,7 +14309,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setslice__(PyObject *self, PyObject *a
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_t___setslice__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_T___setslice__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< int > >::__setslice__(std::vector< std::vector< int > >::difference_type,std::vector< std::vector< int > >::difference_type)\n"
     "    std::vector< std::vector< int > >::__setslice__(std::vector< std::vector< int > >::difference_type,std::vector< std::vector< int > >::difference_type,std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > const &)\n");
@@ -14317,7 +14317,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___delslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___delslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::difference_type arg2 ;
@@ -14331,20 +14331,20 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___delslice__(PyObject *self, PyObject *a
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_t___delslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_T___delslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___delslice__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___delslice__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_t___delslice__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_T___delslice__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< int > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vinteger2d_t___delslice__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vinteger2d_T___delslice__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::vector< int > >::difference_type >(val3);
   try {
@@ -14361,7 +14361,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::difference_type arg2 ;
@@ -14374,12 +14374,12 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___delitem____SWIG_0(PyObject *self, Py_s
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___delitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___delitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_t___delitem__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_T___delitem__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< int > >::difference_type >(val2);
   try {
@@ -14396,7 +14396,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -14408,12 +14408,12 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___getitem____SWIG_0(PyObject *self, Py_s
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___getitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___getitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -14431,7 +14431,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -14444,12 +14444,12 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setitem____SWIG_0(PyObject *self, Py_s
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -14457,10 +14457,10 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setitem____SWIG_0(PyObject *self, Py_s
     std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > *ptr = (std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vinteger2d_t___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vinteger2d_T___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_t___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_T___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > const &""'"); 
     }
     arg3 = ptr;
   }
@@ -14480,7 +14480,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -14491,12 +14491,12 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setitem____SWIG_1(PyObject *self, Py_s
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -14514,7 +14514,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -14525,12 +14525,12 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___delitem____SWIG_1(PyObject *self, Py_s
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___delitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___delitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -14548,13 +14548,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___delitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___delitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_t___delitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_T___delitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -14565,7 +14565,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___delitem__(PyObject *self, PyObject *ar
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vinteger2d_t___delitem____SWIG_1(self, argc, argv);
+        return _wrap_vinteger2d_T___delitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -14579,13 +14579,13 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___delitem__(PyObject *self, PyObject *ar
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vinteger2d_t___delitem____SWIG_0(self, argc, argv);
+        return _wrap_vinteger2d_T___delitem____SWIG_0(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_t___delitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_T___delitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< int > >::__delitem__(std::vector< std::vector< int > >::difference_type)\n"
     "    std::vector< std::vector< int > >::__delitem__(SWIGPY_SLICEOBJECT *)\n");
@@ -14593,7 +14593,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::difference_type arg2 ;
@@ -14607,12 +14607,12 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___getitem____SWIG_1(PyObject *self, Py_s
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___getitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___getitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_t___getitem__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_T___getitem__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< int > >::difference_type >(val2);
   try {
@@ -14628,13 +14628,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___getitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___getitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_t___getitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_T___getitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -14645,7 +14645,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___getitem__(PyObject *self, PyObject *ar
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vinteger2d_t___getitem____SWIG_0(self, argc, argv);
+        return _wrap_vinteger2d_T___getitem____SWIG_0(self, argc, argv);
       }
     }
   }
@@ -14659,13 +14659,13 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___getitem__(PyObject *self, PyObject *ar
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vinteger2d_t___getitem____SWIG_1(self, argc, argv);
+        return _wrap_vinteger2d_T___getitem____SWIG_1(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_t___getitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_T___getitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< int > >::__getitem__(SWIGPY_SLICEOBJECT *)\n"
     "    std::vector< std::vector< int > >::__getitem__(std::vector< std::vector< int > >::difference_type) const\n");
@@ -14673,7 +14673,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::difference_type arg2 ;
@@ -14688,22 +14688,22 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setitem____SWIG_2(PyObject *self, Py_s
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T___setitem__" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_t___setitem__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_T___setitem__" "', argument " "2"" of type '" "std::vector< std::vector< int > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< int > >::difference_type >(val2);
   {
     std::vector< int,std::allocator< int > > *ptr = (std::vector< int,std::allocator< int > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vinteger2d_t___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vinteger2d_T___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_t___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_T___setitem__" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -14721,13 +14721,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t___setitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T___setitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_t___setitem__", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_T___setitem__", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -14738,7 +14738,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setitem__(PyObject *self, PyObject *ar
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vinteger2d_t___setitem____SWIG_1(self, argc, argv);
+        return _wrap_vinteger2d_T___setitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -14754,7 +14754,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setitem__(PyObject *self, PyObject *ar
         int res = swig::asptr(argv[2], (std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vinteger2d_t___setitem____SWIG_0(self, argc, argv);
+          return _wrap_vinteger2d_T___setitem____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -14772,14 +14772,14 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t___setitem__(PyObject *self, PyObject *ar
         int res = swig::asptr(argv[2], (std::vector< int,std::allocator< int > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vinteger2d_t___setitem____SWIG_2(self, argc, argv);
+          return _wrap_vinteger2d_T___setitem____SWIG_2(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_t___setitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_T___setitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< int > >::__setitem__(SWIGPY_SLICEOBJECT *,std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > const &)\n"
     "    std::vector< std::vector< int > >::__setitem__(SWIGPY_SLICEOBJECT *)\n"
@@ -14788,7 +14788,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_pop(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_pop(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -14801,7 +14801,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_pop(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_pop" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_pop" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   try {
@@ -14816,7 +14816,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_append(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_append(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::value_type *arg2 = 0 ;
@@ -14826,20 +14826,20 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_append(PyObject *self, PyObject *args) {
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_t_append", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_T_append", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_append" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_append" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   {
     std::vector< int,std::allocator< int > > *ptr = (std::vector< int,std::allocator< int > > *)0;
     res2 = swig::asptr(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vinteger2d_t_append" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vinteger2d_T_append" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_t_append" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_T_append" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -14853,7 +14853,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vinteger2d_t__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
+SWIGINTERN PyObject *_wrap_new_vinteger2d_T__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *result = 0 ;
   
@@ -14867,7 +14867,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vinteger2d_t__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vinteger2d_T__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int,std::allocator< int > > > *arg1 = 0 ;
   int res1 = SWIG_OLDOBJ ;
@@ -14879,10 +14879,10 @@ SWIGINTERN PyObject *_wrap_new_vinteger2d_t__SWIG_1(PyObject *self, Py_ssize_t n
     std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > *ptr = (std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > > *)0;
     res1 = swig::asptr(swig_obj[0], &ptr);
     if (!SWIG_IsOK(res1)) {
-      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vinteger2d_t" "', argument " "1"" of type '" "std::vector< std::vector< int,std::allocator< int > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vinteger2d_T" "', argument " "1"" of type '" "std::vector< std::vector< int,std::allocator< int > > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vinteger2d_t" "', argument " "1"" of type '" "std::vector< std::vector< int,std::allocator< int > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vinteger2d_T" "', argument " "1"" of type '" "std::vector< std::vector< int,std::allocator< int > > > const &""'"); 
     }
     arg1 = ptr;
   }
@@ -14896,7 +14896,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_empty(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_empty(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -14909,7 +14909,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_empty(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_empty" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_empty" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = (bool)((std::vector< std::vector< int > > const *)arg1)->empty();
@@ -14920,7 +14920,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_size(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_size(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -14933,7 +14933,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_size(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_size" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_size" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = ((std::vector< std::vector< int > > const *)arg1)->size();
@@ -14944,7 +14944,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_swap(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_swap(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int,std::allocator< int > > > *arg2 = 0 ;
@@ -14955,18 +14955,18 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_swap(PyObject *self, PyObject *args) {
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_t_swap", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_T_swap", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_swap" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_swap" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], &argp2, SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t,  0 );
   if (!SWIG_IsOK(res2)) {
-    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vinteger2d_t_swap" "', argument " "2"" of type '" "std::vector< std::vector< int,std::allocator< int > > > &""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vinteger2d_T_swap" "', argument " "2"" of type '" "std::vector< std::vector< int,std::allocator< int > > > &""'"); 
   }
   if (!argp2) {
-    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_t_swap" "', argument " "2"" of type '" "std::vector< std::vector< int,std::allocator< int > > > &""'"); 
+    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_T_swap" "', argument " "2"" of type '" "std::vector< std::vector< int,std::allocator< int > > > &""'"); 
   }
   arg2 = reinterpret_cast< std::vector< std::vector< int,std::allocator< int > > > * >(argp2);
   (arg1)->swap(*arg2);
@@ -14977,7 +14977,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_begin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_begin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -14990,7 +14990,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_begin(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_begin" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_begin" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = (arg1)->begin();
@@ -15002,7 +15002,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_end(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_end(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -15015,7 +15015,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_end(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_end" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_end" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = (arg1)->end();
@@ -15027,7 +15027,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_rbegin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_rbegin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -15040,7 +15040,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_rbegin(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_rbegin" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_rbegin" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = (arg1)->rbegin();
@@ -15052,7 +15052,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_rend(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_rend(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -15065,7 +15065,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_rend(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_rend" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_rend" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = (arg1)->rend();
@@ -15077,7 +15077,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_clear(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_clear(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -15089,7 +15089,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_clear(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_clear" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_clear" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   (arg1)->clear();
@@ -15100,7 +15100,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_get_allocator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_get_allocator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -15113,7 +15113,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_get_allocator(PyObject *self, PyObject *
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_get_allocator" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_get_allocator" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = ((std::vector< std::vector< int > > const *)arg1)->get_allocator();
@@ -15124,7 +15124,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vinteger2d_t__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vinteger2d_T__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > >::size_type arg1 ;
   size_t val1 ;
@@ -15135,7 +15135,7 @@ SWIGINTERN PyObject *_wrap_new_vinteger2d_t__SWIG_2(PyObject *self, Py_ssize_t n
   if ((nobjs < 1) || (nobjs > 1)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vinteger2d_t" "', argument " "1"" of type '" "std::vector< std::vector< int > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vinteger2d_T" "', argument " "1"" of type '" "std::vector< std::vector< int > >::size_type""'");
   } 
   arg1 = static_cast< std::vector< std::vector< int > >::size_type >(val1);
   result = (std::vector< std::vector< int > > *)new std::vector< std::vector< int > >(arg1);
@@ -15146,7 +15146,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_pop_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_pop_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -15158,7 +15158,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_pop_back(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_pop_back" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_pop_back" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   (arg1)->pop_back();
@@ -15169,7 +15169,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::size_type arg2 ;
@@ -15182,12 +15182,12 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_resize__SWIG_0(PyObject *self, Py_ssize_
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_resize" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_resize" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_t_resize" "', argument " "2"" of type '" "std::vector< std::vector< int > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_T_resize" "', argument " "2"" of type '" "std::vector< std::vector< int > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< int > >::size_type >(val2);
   (arg1)->resize(arg2);
@@ -15198,7 +15198,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::iterator arg2 ;
@@ -15212,18 +15212,18 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_erase__SWIG_0(PyObject *self, Py_ssize_t
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_erase" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_erase" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t_erase" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T_erase" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t_erase" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T_erase" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
     }
   }
   result = std_vector_Sl_std_vector_Sl_int_Sg__Sg__erase__SWIG_0(arg1,SWIG_STD_MOVE(arg2));
@@ -15235,7 +15235,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::iterator arg2 ;
@@ -15252,29 +15252,29 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_erase__SWIG_1(PyObject *self, Py_ssize_t
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_erase" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_erase" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t_erase" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T_erase" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t_erase" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T_erase" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
     }
   }
   res3 = SWIG_ConvertPtr(swig_obj[2], SWIG_as_voidptrptr(&iter3), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res3) || !iter3) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t_erase" "', argument " "3"" of type '" "std::vector< std::vector< int > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T_erase" "', argument " "3"" of type '" "std::vector< std::vector< int > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *>(iter3);
     if (iter_t) {
       arg3 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t_erase" "', argument " "3"" of type '" "std::vector< std::vector< int > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T_erase" "', argument " "3"" of type '" "std::vector< std::vector< int > >::iterator""'");
     }
   }
   result = std_vector_Sl_std_vector_Sl_int_Sg__Sg__erase__SWIG_1(arg1,SWIG_STD_MOVE(arg2),SWIG_STD_MOVE(arg3));
@@ -15286,13 +15286,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_erase(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_erase(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_t_erase", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_T_erase", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -15303,7 +15303,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_erase(PyObject *self, PyObject *args) {
       int res = SWIG_ConvertPtr(argv[1], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
       _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *>(iter) != 0));
       if (_v) {
-        return _wrap_vinteger2d_t_erase__SWIG_0(self, argc, argv);
+        return _wrap_vinteger2d_T_erase__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -15320,14 +15320,14 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_erase(PyObject *self, PyObject *args) {
         int res = SWIG_ConvertPtr(argv[2], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
         _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *>(iter) != 0));
         if (_v) {
-          return _wrap_vinteger2d_t_erase__SWIG_1(self, argc, argv);
+          return _wrap_vinteger2d_T_erase__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_t_erase'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_T_erase'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< int > >::erase(std::vector< std::vector< int > >::iterator)\n"
     "    std::vector< std::vector< int > >::erase(std::vector< std::vector< int > >::iterator,std::vector< std::vector< int > >::iterator)\n");
@@ -15335,7 +15335,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vinteger2d_t__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vinteger2d_T__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > >::size_type arg1 ;
   std::vector< std::vector< int > >::value_type *arg2 = 0 ;
@@ -15348,17 +15348,17 @@ SWIGINTERN PyObject *_wrap_new_vinteger2d_t__SWIG_3(PyObject *self, Py_ssize_t n
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vinteger2d_t" "', argument " "1"" of type '" "std::vector< std::vector< int > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vinteger2d_T" "', argument " "1"" of type '" "std::vector< std::vector< int > >::size_type""'");
   } 
   arg1 = static_cast< std::vector< std::vector< int > >::size_type >(val1);
   {
     std::vector< int,std::allocator< int > > *ptr = (std::vector< int,std::allocator< int > > *)0;
     res2 = swig::asptr(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "new_vinteger2d_t" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "new_vinteger2d_T" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vinteger2d_t" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vinteger2d_T" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -15372,16 +15372,16 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vinteger2d_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_new_vinteger2d_T(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vinteger2d_t", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vinteger2d_T", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 0) {
-    return _wrap_new_vinteger2d_t__SWIG_0(self, argc, argv);
+    return _wrap_new_vinteger2d_T__SWIG_0(self, argc, argv);
   }
   if (argc == 1) {
     int _v = 0;
@@ -15390,7 +15390,7 @@ SWIGINTERN PyObject *_wrap_new_vinteger2d_t(PyObject *self, PyObject *args) {
       _v = SWIG_CheckState(res);
     }
     if (_v) {
-      return _wrap_new_vinteger2d_t__SWIG_2(self, argc, argv);
+      return _wrap_new_vinteger2d_T__SWIG_2(self, argc, argv);
     }
   }
   if (argc == 1) {
@@ -15398,7 +15398,7 @@ SWIGINTERN PyObject *_wrap_new_vinteger2d_t(PyObject *self, PyObject *args) {
     int res = swig::asptr(argv[0], (std::vector< std::vector< int,std::allocator< int > >,std::allocator< std::vector< int,std::allocator< int > > > >**)(0));
     _v = SWIG_CheckState(res);
     if (_v) {
-      return _wrap_new_vinteger2d_t__SWIG_1(self, argc, argv);
+      return _wrap_new_vinteger2d_T__SWIG_1(self, argc, argv);
     }
   }
   if (argc == 2) {
@@ -15411,13 +15411,13 @@ SWIGINTERN PyObject *_wrap_new_vinteger2d_t(PyObject *self, PyObject *args) {
       int res = swig::asptr(argv[1], (std::vector< int,std::allocator< int > >**)(0));
       _v = SWIG_CheckState(res);
       if (_v) {
-        return _wrap_new_vinteger2d_t__SWIG_3(self, argc, argv);
+        return _wrap_new_vinteger2d_T__SWIG_3(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vinteger2d_t'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vinteger2d_T'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< int > >::vector()\n"
     "    std::vector< std::vector< int > >::vector(std::vector< std::vector< int,std::allocator< int > > > const &)\n"
@@ -15427,7 +15427,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_push_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_push_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::value_type *arg2 = 0 ;
@@ -15437,20 +15437,20 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_push_back(PyObject *self, PyObject *args
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_t_push_back", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_T_push_back", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_push_back" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_push_back" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   {
     std::vector< int,std::allocator< int > > *ptr = (std::vector< int,std::allocator< int > > *)0;
     res2 = swig::asptr(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vinteger2d_t_push_back" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vinteger2d_T_push_back" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_t_push_back" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_T_push_back" "', argument " "2"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -15464,7 +15464,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_front(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_front(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -15477,7 +15477,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_front(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_front" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_front" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = (std::vector< std::vector< int > >::value_type *) &((std::vector< std::vector< int > > const *)arg1)->front();
@@ -15489,7 +15489,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -15502,7 +15502,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_back(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_back" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_back" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = (std::vector< std::vector< int > >::value_type *) &((std::vector< std::vector< int > > const *)arg1)->back();
@@ -15514,7 +15514,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_assign(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_assign(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::size_type arg2 ;
@@ -15527,25 +15527,25 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_assign(PyObject *self, PyObject *args) {
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_t_assign", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_T_assign", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_assign" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_assign" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_t_assign" "', argument " "2"" of type '" "std::vector< std::vector< int > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_T_assign" "', argument " "2"" of type '" "std::vector< std::vector< int > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< int > >::size_type >(val2);
   {
     std::vector< int,std::allocator< int > > *ptr = (std::vector< int,std::allocator< int > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vinteger2d_t_assign" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vinteger2d_T_assign" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_t_assign" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_T_assign" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -15559,7 +15559,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::size_type arg2 ;
@@ -15574,22 +15574,22 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_resize__SWIG_1(PyObject *self, Py_ssize_
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_resize" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_resize" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_t_resize" "', argument " "2"" of type '" "std::vector< std::vector< int > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_T_resize" "', argument " "2"" of type '" "std::vector< std::vector< int > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< int > >::size_type >(val2);
   {
     std::vector< int,std::allocator< int > > *ptr = (std::vector< int,std::allocator< int > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vinteger2d_t_resize" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vinteger2d_T_resize" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_t_resize" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_T_resize" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -15603,13 +15603,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_resize(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_resize(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_t_resize", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_T_resize", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -15621,7 +15621,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_resize(PyObject *self, PyObject *args) {
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vinteger2d_t_resize__SWIG_0(self, argc, argv);
+        return _wrap_vinteger2d_T_resize__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -15638,14 +15638,14 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_resize(PyObject *self, PyObject *args) {
         int res = swig::asptr(argv[2], (std::vector< int,std::allocator< int > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vinteger2d_t_resize__SWIG_1(self, argc, argv);
+          return _wrap_vinteger2d_T_resize__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_t_resize'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_T_resize'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< int > >::resize(std::vector< std::vector< int > >::size_type)\n"
     "    std::vector< std::vector< int > >::resize(std::vector< std::vector< int > >::size_type,std::vector< std::vector< int > >::value_type const &)\n");
@@ -15653,7 +15653,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::iterator arg2 ;
@@ -15669,28 +15669,28 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_insert__SWIG_0(PyObject *self, Py_ssize_
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_insert" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_insert" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t_insert" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T_insert" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t_insert" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T_insert" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
     }
   }
   {
     std::vector< int,std::allocator< int > > *ptr = (std::vector< int,std::allocator< int > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vinteger2d_t_insert" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vinteger2d_T_insert" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_t_insert" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_T_insert" "', argument " "3"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -15705,7 +15705,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::iterator arg2 ;
@@ -15723,33 +15723,33 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_insert__SWIG_1(PyObject *self, Py_ssize_
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_insert" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_insert" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t_insert" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T_insert" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::vector< int > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_t_insert" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vinteger2d_T_insert" "', argument " "2"" of type '" "std::vector< std::vector< int > >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_size_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vinteger2d_t_insert" "', argument " "3"" of type '" "std::vector< std::vector< int > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vinteger2d_T_insert" "', argument " "3"" of type '" "std::vector< std::vector< int > >::size_type""'");
   } 
   arg3 = static_cast< std::vector< std::vector< int > >::size_type >(val3);
   {
     std::vector< int,std::allocator< int > > *ptr = (std::vector< int,std::allocator< int > > *)0;
     res4 = swig::asptr(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vinteger2d_t_insert" "', argument " "4"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vinteger2d_T_insert" "', argument " "4"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_t_insert" "', argument " "4"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vinteger2d_T_insert" "', argument " "4"" of type '" "std::vector< std::vector< int > >::value_type const &""'"); 
     }
     arg4 = ptr;
   }
@@ -15763,13 +15763,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_insert(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_insert(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_t_insert", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vinteger2d_T_insert", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -15783,7 +15783,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_insert(PyObject *self, PyObject *args) {
         int res = swig::asptr(argv[2], (std::vector< int,std::allocator< int > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vinteger2d_t_insert__SWIG_0(self, argc, argv);
+          return _wrap_vinteger2d_T_insert__SWIG_0(self, argc, argv);
         }
       }
     }
@@ -15805,7 +15805,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_insert(PyObject *self, PyObject *args) {
           int res = swig::asptr(argv[3], (std::vector< int,std::allocator< int > >**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vinteger2d_t_insert__SWIG_1(self, argc, argv);
+            return _wrap_vinteger2d_T_insert__SWIG_1(self, argc, argv);
           }
         }
       }
@@ -15813,7 +15813,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_insert(PyObject *self, PyObject *args) {
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_t_insert'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vinteger2d_T_insert'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::vector< int > >::insert(std::vector< std::vector< int > >::iterator,std::vector< std::vector< int > >::value_type const &)\n"
     "    std::vector< std::vector< int > >::insert(std::vector< std::vector< int > >::iterator,std::vector< std::vector< int > >::size_type,std::vector< std::vector< int > >::value_type const &)\n");
@@ -15821,7 +15821,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_reserve(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_reserve(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   std::vector< std::vector< int > >::size_type arg2 ;
@@ -15832,15 +15832,15 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_reserve(PyObject *self, PyObject *args)
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_t_reserve", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vinteger2d_T_reserve", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_reserve" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_reserve" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_t_reserve" "', argument " "2"" of type '" "std::vector< std::vector< int > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vinteger2d_T_reserve" "', argument " "2"" of type '" "std::vector< std::vector< int > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::vector< int > >::size_type >(val2);
   (arg1)->reserve(arg2);
@@ -15851,7 +15851,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vinteger2d_t_capacity(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vinteger2d_T_capacity(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -15864,7 +15864,7 @@ SWIGINTERN PyObject *_wrap_vinteger2d_t_capacity(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_t_capacity" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vinteger2d_T_capacity" "', argument " "1"" of type '" "std::vector< std::vector< int > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   result = ((std::vector< std::vector< int > > const *)arg1)->capacity();
@@ -15875,7 +15875,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_delete_vinteger2d_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_delete_vinteger2d_T(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::vector< int > > *arg1 = (std::vector< std::vector< int > > *) 0 ;
   void *argp1 = 0 ;
@@ -15887,7 +15887,7 @@ SWIGINTERN PyObject *_wrap_delete_vinteger2d_t(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, SWIG_POINTER_DISOWN |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vinteger2d_t" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vinteger2d_T" "', argument " "1"" of type '" "std::vector< std::vector< int > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::vector< int > > * >(argp1);
   {
@@ -15908,18 +15908,18 @@ fail:
 }
 
 
-SWIGINTERN PyObject *vinteger2d_t_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vinteger2d_T_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   PyObject *obj;
   if (!SWIG_Python_UnpackTuple(args, "swigregister", 1, 1, &obj)) return NULL;
   SWIG_TypeNewClientData(SWIGTYPE_p_std__vectorT_std__vectorT_int_t_t, SWIG_NewClientData(obj));
   return SWIG_Py_Void();
 }
 
-SWIGINTERN PyObject *vinteger2d_t_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vinteger2d_T_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   return SWIG_Python_InitShadowInstance(args);
 }
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_iterator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_iterator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   PyObject **arg2 = (PyObject **) 0 ;
@@ -15934,7 +15934,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_iterator(PyObject *self, PyObjec
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_iterator" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_iterator" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = (swig::SwigPyIterator *)std_vector_Sl_unsigned_SS_long_Sg__iterator(arg1,arg2);
@@ -15945,7 +15945,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___nonzero__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___nonzero__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -15958,7 +15958,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___nonzero__(PyObject *self, PyOb
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___nonzero__" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___nonzero__" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = (bool)std_vector_Sl_unsigned_SS_long_Sg____nonzero__((std::vector< unsigned long > const *)arg1);
@@ -15969,7 +15969,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___bool__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___bool__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -15982,7 +15982,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___bool__(PyObject *self, PyObjec
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___bool__" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___bool__" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = (bool)std_vector_Sl_unsigned_SS_long_Sg____bool__((std::vector< unsigned long > const *)arg1);
@@ -15993,7 +15993,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___len__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___len__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -16006,7 +16006,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___len__(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___len__" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___len__" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = std_vector_Sl_unsigned_SS_long_Sg____len__((std::vector< unsigned long > const *)arg1);
@@ -16017,7 +16017,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___getslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___getslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::difference_type arg2 ;
@@ -16032,20 +16032,20 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___getslice__(PyObject *self, PyO
   std::vector< unsigned long,std::allocator< unsigned long > > *result = 0 ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_t___getslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_T___getslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___getslice__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___getslice__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t___getslice__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T___getslice__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< unsigned long >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_t___getslice__" "', argument " "3"" of type '" "std::vector< unsigned long >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_T___getslice__" "', argument " "3"" of type '" "std::vector< unsigned long >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< unsigned long >::difference_type >(val3);
   try {
@@ -16062,7 +16062,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::difference_type arg2 ;
@@ -16078,17 +16078,17 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setslice____SWIG_0(PyObject *s
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___setslice__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___setslice__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t___setslice__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T___setslice__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< unsigned long >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_t___setslice__" "', argument " "3"" of type '" "std::vector< unsigned long >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_T___setslice__" "', argument " "3"" of type '" "std::vector< unsigned long >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< unsigned long >::difference_type >(val3);
   try {
@@ -16105,7 +16105,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::difference_type arg2 ;
@@ -16123,27 +16123,27 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setslice____SWIG_1(PyObject *s
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___setslice__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___setslice__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t___setslice__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T___setslice__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< unsigned long >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_t___setslice__" "', argument " "3"" of type '" "std::vector< unsigned long >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_T___setslice__" "', argument " "3"" of type '" "std::vector< unsigned long >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< unsigned long >::difference_type >(val3);
   {
     std::vector< unsigned long,std::allocator< unsigned long > > *ptr = (std::vector< unsigned long,std::allocator< unsigned long > > *)0;
     res4 = swig::asptr(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_longinteger_t___setslice__" "', argument " "4"" of type '" "std::vector< unsigned long,std::allocator< unsigned long > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_longinteger_T___setslice__" "', argument " "4"" of type '" "std::vector< unsigned long,std::allocator< unsigned long > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_longinteger_t___setslice__" "', argument " "4"" of type '" "std::vector< unsigned long,std::allocator< unsigned long > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_longinteger_T___setslice__" "', argument " "4"" of type '" "std::vector< unsigned long,std::allocator< unsigned long > > const &""'"); 
     }
     arg4 = ptr;
   }
@@ -16163,13 +16163,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___setslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___setslice__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_t___setslice__", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_T___setslice__", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -16186,7 +16186,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setslice__(PyObject *self, PyO
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_longinteger_t___setslice____SWIG_0(self, argc, argv);
+          return _wrap_vector_longinteger_T___setslice____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -16209,7 +16209,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setslice__(PyObject *self, PyO
           int res = swig::asptr(argv[3], (std::vector< unsigned long,std::allocator< unsigned long > >**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vector_longinteger_t___setslice____SWIG_1(self, argc, argv);
+            return _wrap_vector_longinteger_T___setslice____SWIG_1(self, argc, argv);
           }
         }
       }
@@ -16217,7 +16217,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setslice__(PyObject *self, PyO
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_t___setslice__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_T___setslice__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< unsigned long >::__setslice__(std::vector< unsigned long >::difference_type,std::vector< unsigned long >::difference_type)\n"
     "    std::vector< unsigned long >::__setslice__(std::vector< unsigned long >::difference_type,std::vector< unsigned long >::difference_type,std::vector< unsigned long,std::allocator< unsigned long > > const &)\n");
@@ -16225,7 +16225,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___delslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___delslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::difference_type arg2 ;
@@ -16239,20 +16239,20 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___delslice__(PyObject *self, PyO
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_t___delslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_T___delslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___delslice__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___delslice__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t___delslice__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T___delslice__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< unsigned long >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_t___delslice__" "', argument " "3"" of type '" "std::vector< unsigned long >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_T___delslice__" "', argument " "3"" of type '" "std::vector< unsigned long >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< unsigned long >::difference_type >(val3);
   try {
@@ -16269,7 +16269,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::difference_type arg2 ;
@@ -16282,12 +16282,12 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___delitem____SWIG_0(PyObject *se
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___delitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___delitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t___delitem__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T___delitem__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< unsigned long >::difference_type >(val2);
   try {
@@ -16304,7 +16304,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -16316,12 +16316,12 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___getitem____SWIG_0(PyObject *se
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___getitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___getitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -16339,7 +16339,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -16352,12 +16352,12 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setitem____SWIG_0(PyObject *se
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___setitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___setitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -16365,10 +16365,10 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setitem____SWIG_0(PyObject *se
     std::vector< unsigned long,std::allocator< unsigned long > > *ptr = (std::vector< unsigned long,std::allocator< unsigned long > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_longinteger_t___setitem__" "', argument " "3"" of type '" "std::vector< unsigned long,std::allocator< unsigned long > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_longinteger_T___setitem__" "', argument " "3"" of type '" "std::vector< unsigned long,std::allocator< unsigned long > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_longinteger_t___setitem__" "', argument " "3"" of type '" "std::vector< unsigned long,std::allocator< unsigned long > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_longinteger_T___setitem__" "', argument " "3"" of type '" "std::vector< unsigned long,std::allocator< unsigned long > > const &""'"); 
     }
     arg3 = ptr;
   }
@@ -16388,7 +16388,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -16399,12 +16399,12 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setitem____SWIG_1(PyObject *se
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___setitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___setitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -16422,7 +16422,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -16433,12 +16433,12 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___delitem____SWIG_1(PyObject *se
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___delitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___delitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -16456,13 +16456,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___delitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___delitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_t___delitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_T___delitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -16473,7 +16473,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___delitem__(PyObject *self, PyOb
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_longinteger_t___delitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_longinteger_T___delitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -16487,13 +16487,13 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___delitem__(PyObject *self, PyOb
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_longinteger_t___delitem____SWIG_0(self, argc, argv);
+        return _wrap_vector_longinteger_T___delitem____SWIG_0(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_t___delitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_T___delitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< unsigned long >::__delitem__(std::vector< unsigned long >::difference_type)\n"
     "    std::vector< unsigned long >::__delitem__(SWIGPY_SLICEOBJECT *)\n");
@@ -16501,7 +16501,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::difference_type arg2 ;
@@ -16515,12 +16515,12 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___getitem____SWIG_1(PyObject *se
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___getitem__" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___getitem__" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t___getitem__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T___getitem__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< unsigned long >::difference_type >(val2);
   try {
@@ -16536,13 +16536,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___getitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___getitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_t___getitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_T___getitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -16553,7 +16553,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___getitem__(PyObject *self, PyOb
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_longinteger_t___getitem____SWIG_0(self, argc, argv);
+        return _wrap_vector_longinteger_T___getitem____SWIG_0(self, argc, argv);
       }
     }
   }
@@ -16567,13 +16567,13 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___getitem__(PyObject *self, PyOb
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_longinteger_t___getitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_longinteger_T___getitem____SWIG_1(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_t___getitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_T___getitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< unsigned long >::__getitem__(SWIGPY_SLICEOBJECT *)\n"
     "    std::vector< unsigned long >::__getitem__(std::vector< unsigned long >::difference_type) const\n");
@@ -16581,7 +16581,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::difference_type arg2 ;
@@ -16598,17 +16598,17 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setitem____SWIG_2(PyObject *se
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t___setitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T___setitem__" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t___setitem__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T___setitem__" "', argument " "2"" of type '" "std::vector< unsigned long >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< unsigned long >::difference_type >(val2);
   ecode3 = SWIG_AsVal_unsigned_SS_long(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_t___setitem__" "', argument " "3"" of type '" "std::vector< unsigned long >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_T___setitem__" "', argument " "3"" of type '" "std::vector< unsigned long >::value_type""'");
   } 
   temp3 = static_cast< std::vector< unsigned long >::value_type >(val3);
   arg3 = &temp3;
@@ -16624,13 +16624,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t___setitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T___setitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_t___setitem__", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_T___setitem__", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -16641,7 +16641,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setitem__(PyObject *self, PyOb
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_longinteger_t___setitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_longinteger_T___setitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -16657,7 +16657,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setitem__(PyObject *self, PyOb
         int res = swig::asptr(argv[2], (std::vector< unsigned long,std::allocator< unsigned long > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vector_longinteger_t___setitem____SWIG_0(self, argc, argv);
+          return _wrap_vector_longinteger_T___setitem____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -16677,14 +16677,14 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t___setitem__(PyObject *self, PyOb
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_longinteger_t___setitem____SWIG_2(self, argc, argv);
+          return _wrap_vector_longinteger_T___setitem____SWIG_2(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_t___setitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_T___setitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< unsigned long >::__setitem__(SWIGPY_SLICEOBJECT *,std::vector< unsigned long,std::allocator< unsigned long > > const &)\n"
     "    std::vector< unsigned long >::__setitem__(SWIGPY_SLICEOBJECT *)\n"
@@ -16693,7 +16693,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_pop(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_pop(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -16706,7 +16706,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_pop(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_pop" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_pop" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   try {
@@ -16721,7 +16721,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_append(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_append(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::value_type *arg2 = 0 ;
@@ -16733,15 +16733,15 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_append(PyObject *self, PyObject
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_t_append", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_T_append", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_append" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_append" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_unsigned_SS_long(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t_append" "', argument " "2"" of type '" "std::vector< unsigned long >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T_append" "', argument " "2"" of type '" "std::vector< unsigned long >::value_type""'");
   } 
   temp2 = static_cast< std::vector< unsigned long >::value_type >(val2);
   arg2 = &temp2;
@@ -16753,7 +16753,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_longinteger_t__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
+SWIGINTERN PyObject *_wrap_new_vector_longinteger_T__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *result = 0 ;
   
@@ -16767,7 +16767,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_longinteger_t__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_longinteger_T__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = 0 ;
   int res1 = SWIG_OLDOBJ ;
@@ -16779,10 +16779,10 @@ SWIGINTERN PyObject *_wrap_new_vector_longinteger_t__SWIG_1(PyObject *self, Py_s
     std::vector< unsigned long,std::allocator< unsigned long > > *ptr = (std::vector< unsigned long,std::allocator< unsigned long > > *)0;
     res1 = swig::asptr(swig_obj[0], &ptr);
     if (!SWIG_IsOK(res1)) {
-      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vector_longinteger_t" "', argument " "1"" of type '" "std::vector< unsigned long > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vector_longinteger_T" "', argument " "1"" of type '" "std::vector< unsigned long > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_longinteger_t" "', argument " "1"" of type '" "std::vector< unsigned long > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_longinteger_T" "', argument " "1"" of type '" "std::vector< unsigned long > const &""'"); 
     }
     arg1 = ptr;
   }
@@ -16796,7 +16796,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_empty(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_empty(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -16809,7 +16809,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_empty(PyObject *self, PyObject *
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_empty" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_empty" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = (bool)((std::vector< unsigned long > const *)arg1)->empty();
@@ -16820,7 +16820,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_size(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_size(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -16833,7 +16833,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_size(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_size" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_size" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = ((std::vector< unsigned long > const *)arg1)->size();
@@ -16844,7 +16844,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_swap(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_swap(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long > *arg2 = 0 ;
@@ -16855,18 +16855,18 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_swap(PyObject *self, PyObject *a
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_t_swap", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_T_swap", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_swap" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_swap" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], &argp2, SWIGTYPE_p_std__vectorT_unsigned_long_t,  0 );
   if (!SWIG_IsOK(res2)) {
-    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_longinteger_t_swap" "', argument " "2"" of type '" "std::vector< unsigned long > &""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_longinteger_T_swap" "', argument " "2"" of type '" "std::vector< unsigned long > &""'"); 
   }
   if (!argp2) {
-    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_longinteger_t_swap" "', argument " "2"" of type '" "std::vector< unsigned long > &""'"); 
+    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_longinteger_T_swap" "', argument " "2"" of type '" "std::vector< unsigned long > &""'"); 
   }
   arg2 = reinterpret_cast< std::vector< unsigned long > * >(argp2);
   (arg1)->swap(*arg2);
@@ -16877,7 +16877,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_begin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_begin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -16890,7 +16890,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_begin(PyObject *self, PyObject *
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_begin" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_begin" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = (arg1)->begin();
@@ -16902,7 +16902,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_end(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_end(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -16915,7 +16915,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_end(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_end" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_end" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = (arg1)->end();
@@ -16927,7 +16927,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_rbegin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_rbegin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -16940,7 +16940,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_rbegin(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_rbegin" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_rbegin" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = (arg1)->rbegin();
@@ -16952,7 +16952,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_rend(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_rend(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -16965,7 +16965,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_rend(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_rend" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_rend" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = (arg1)->rend();
@@ -16977,7 +16977,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_clear(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_clear(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -16989,7 +16989,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_clear(PyObject *self, PyObject *
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_clear" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_clear" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   (arg1)->clear();
@@ -17000,7 +17000,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_get_allocator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_get_allocator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -17013,7 +17013,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_get_allocator(PyObject *self, Py
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_get_allocator" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_get_allocator" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = ((std::vector< unsigned long > const *)arg1)->get_allocator();
@@ -17024,7 +17024,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_longinteger_t__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_longinteger_T__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long >::size_type arg1 ;
   size_t val1 ;
@@ -17035,7 +17035,7 @@ SWIGINTERN PyObject *_wrap_new_vector_longinteger_t__SWIG_2(PyObject *self, Py_s
   if ((nobjs < 1) || (nobjs > 1)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_longinteger_t" "', argument " "1"" of type '" "std::vector< unsigned long >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_longinteger_T" "', argument " "1"" of type '" "std::vector< unsigned long >::size_type""'");
   } 
   arg1 = static_cast< std::vector< unsigned long >::size_type >(val1);
   result = (std::vector< unsigned long > *)new std::vector< unsigned long >(arg1);
@@ -17046,7 +17046,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_pop_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_pop_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -17058,7 +17058,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_pop_back(PyObject *self, PyObjec
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_pop_back" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_pop_back" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   (arg1)->pop_back();
@@ -17069,7 +17069,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::size_type arg2 ;
@@ -17082,12 +17082,12 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_resize__SWIG_0(PyObject *self, P
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_resize" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_resize" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t_resize" "', argument " "2"" of type '" "std::vector< unsigned long >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T_resize" "', argument " "2"" of type '" "std::vector< unsigned long >::size_type""'");
   } 
   arg2 = static_cast< std::vector< unsigned long >::size_type >(val2);
   (arg1)->resize(arg2);
@@ -17098,7 +17098,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::iterator arg2 ;
@@ -17112,18 +17112,18 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_erase__SWIG_0(PyObject *self, Py
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_erase" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_erase" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t_erase" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T_erase" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t_erase" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T_erase" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
     }
   }
   result = std_vector_Sl_unsigned_SS_long_Sg__erase__SWIG_0(arg1,SWIG_STD_MOVE(arg2));
@@ -17135,7 +17135,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::iterator arg2 ;
@@ -17152,29 +17152,29 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_erase__SWIG_1(PyObject *self, Py
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_erase" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_erase" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t_erase" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T_erase" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t_erase" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T_erase" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
     }
   }
   res3 = SWIG_ConvertPtr(swig_obj[2], SWIG_as_voidptrptr(&iter3), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res3) || !iter3) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t_erase" "', argument " "3"" of type '" "std::vector< unsigned long >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T_erase" "', argument " "3"" of type '" "std::vector< unsigned long >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *>(iter3);
     if (iter_t) {
       arg3 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t_erase" "', argument " "3"" of type '" "std::vector< unsigned long >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T_erase" "', argument " "3"" of type '" "std::vector< unsigned long >::iterator""'");
     }
   }
   result = std_vector_Sl_unsigned_SS_long_Sg__erase__SWIG_1(arg1,SWIG_STD_MOVE(arg2),SWIG_STD_MOVE(arg3));
@@ -17186,13 +17186,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_erase(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_erase(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_t_erase", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_T_erase", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -17203,7 +17203,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_erase(PyObject *self, PyObject *
       int res = SWIG_ConvertPtr(argv[1], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
       _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *>(iter) != 0));
       if (_v) {
-        return _wrap_vector_longinteger_t_erase__SWIG_0(self, argc, argv);
+        return _wrap_vector_longinteger_T_erase__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -17220,14 +17220,14 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_erase(PyObject *self, PyObject *
         int res = SWIG_ConvertPtr(argv[2], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
         _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *>(iter) != 0));
         if (_v) {
-          return _wrap_vector_longinteger_t_erase__SWIG_1(self, argc, argv);
+          return _wrap_vector_longinteger_T_erase__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_t_erase'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_T_erase'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< unsigned long >::erase(std::vector< unsigned long >::iterator)\n"
     "    std::vector< unsigned long >::erase(std::vector< unsigned long >::iterator,std::vector< unsigned long >::iterator)\n");
@@ -17235,7 +17235,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_longinteger_t__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_longinteger_T__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long >::size_type arg1 ;
   std::vector< unsigned long >::value_type *arg2 = 0 ;
@@ -17250,12 +17250,12 @@ SWIGINTERN PyObject *_wrap_new_vector_longinteger_t__SWIG_3(PyObject *self, Py_s
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_longinteger_t" "', argument " "1"" of type '" "std::vector< unsigned long >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_longinteger_T" "', argument " "1"" of type '" "std::vector< unsigned long >::size_type""'");
   } 
   arg1 = static_cast< std::vector< unsigned long >::size_type >(val1);
   ecode2 = SWIG_AsVal_unsigned_SS_long(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "new_vector_longinteger_t" "', argument " "2"" of type '" "std::vector< unsigned long >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "new_vector_longinteger_T" "', argument " "2"" of type '" "std::vector< unsigned long >::value_type""'");
   } 
   temp2 = static_cast< std::vector< unsigned long >::value_type >(val2);
   arg2 = &temp2;
@@ -17267,16 +17267,16 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_longinteger_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_new_vector_longinteger_T(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vector_longinteger_t", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vector_longinteger_T", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 0) {
-    return _wrap_new_vector_longinteger_t__SWIG_0(self, argc, argv);
+    return _wrap_new_vector_longinteger_T__SWIG_0(self, argc, argv);
   }
   if (argc == 1) {
     int _v = 0;
@@ -17285,7 +17285,7 @@ SWIGINTERN PyObject *_wrap_new_vector_longinteger_t(PyObject *self, PyObject *ar
       _v = SWIG_CheckState(res);
     }
     if (_v) {
-      return _wrap_new_vector_longinteger_t__SWIG_2(self, argc, argv);
+      return _wrap_new_vector_longinteger_T__SWIG_2(self, argc, argv);
     }
   }
   if (argc == 1) {
@@ -17293,7 +17293,7 @@ SWIGINTERN PyObject *_wrap_new_vector_longinteger_t(PyObject *self, PyObject *ar
     int res = swig::asptr(argv[0], (std::vector< unsigned long,std::allocator< unsigned long > >**)(0));
     _v = SWIG_CheckState(res);
     if (_v) {
-      return _wrap_new_vector_longinteger_t__SWIG_1(self, argc, argv);
+      return _wrap_new_vector_longinteger_T__SWIG_1(self, argc, argv);
     }
   }
   if (argc == 2) {
@@ -17308,13 +17308,13 @@ SWIGINTERN PyObject *_wrap_new_vector_longinteger_t(PyObject *self, PyObject *ar
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_new_vector_longinteger_t__SWIG_3(self, argc, argv);
+        return _wrap_new_vector_longinteger_T__SWIG_3(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vector_longinteger_t'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vector_longinteger_T'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< unsigned long >::vector()\n"
     "    std::vector< unsigned long >::vector(std::vector< unsigned long > const &)\n"
@@ -17324,7 +17324,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_push_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_push_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::value_type *arg2 = 0 ;
@@ -17336,15 +17336,15 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_push_back(PyObject *self, PyObje
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_t_push_back", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_T_push_back", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_push_back" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_push_back" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_unsigned_SS_long(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t_push_back" "', argument " "2"" of type '" "std::vector< unsigned long >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T_push_back" "', argument " "2"" of type '" "std::vector< unsigned long >::value_type""'");
   } 
   temp2 = static_cast< std::vector< unsigned long >::value_type >(val2);
   arg2 = &temp2;
@@ -17356,7 +17356,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_front(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_front(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -17369,7 +17369,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_front(PyObject *self, PyObject *
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_front" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_front" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = (std::vector< unsigned long >::value_type *) &((std::vector< unsigned long > const *)arg1)->front();
@@ -17381,7 +17381,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -17394,7 +17394,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_back(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_back" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_back" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = (std::vector< unsigned long >::value_type *) &((std::vector< unsigned long > const *)arg1)->back();
@@ -17406,7 +17406,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_assign(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_assign(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::size_type arg2 ;
@@ -17421,20 +17421,20 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_assign(PyObject *self, PyObject
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_t_assign", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_T_assign", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_assign" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_assign" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t_assign" "', argument " "2"" of type '" "std::vector< unsigned long >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T_assign" "', argument " "2"" of type '" "std::vector< unsigned long >::size_type""'");
   } 
   arg2 = static_cast< std::vector< unsigned long >::size_type >(val2);
   ecode3 = SWIG_AsVal_unsigned_SS_long(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_t_assign" "', argument " "3"" of type '" "std::vector< unsigned long >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_T_assign" "', argument " "3"" of type '" "std::vector< unsigned long >::value_type""'");
   } 
   temp3 = static_cast< std::vector< unsigned long >::value_type >(val3);
   arg3 = &temp3;
@@ -17446,7 +17446,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::size_type arg2 ;
@@ -17463,17 +17463,17 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_resize__SWIG_1(PyObject *self, P
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_resize" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_resize" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t_resize" "', argument " "2"" of type '" "std::vector< unsigned long >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T_resize" "', argument " "2"" of type '" "std::vector< unsigned long >::size_type""'");
   } 
   arg2 = static_cast< std::vector< unsigned long >::size_type >(val2);
   ecode3 = SWIG_AsVal_unsigned_SS_long(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_t_resize" "', argument " "3"" of type '" "std::vector< unsigned long >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_T_resize" "', argument " "3"" of type '" "std::vector< unsigned long >::value_type""'");
   } 
   temp3 = static_cast< std::vector< unsigned long >::value_type >(val3);
   arg3 = &temp3;
@@ -17485,13 +17485,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_resize(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_resize(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_t_resize", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_T_resize", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -17503,7 +17503,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_resize(PyObject *self, PyObject
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_longinteger_t_resize__SWIG_0(self, argc, argv);
+        return _wrap_vector_longinteger_T_resize__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -17522,14 +17522,14 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_resize(PyObject *self, PyObject
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_longinteger_t_resize__SWIG_1(self, argc, argv);
+          return _wrap_vector_longinteger_T_resize__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_t_resize'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_T_resize'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< unsigned long >::resize(std::vector< unsigned long >::size_type)\n"
     "    std::vector< unsigned long >::resize(std::vector< unsigned long >::size_type,std::vector< unsigned long >::value_type const &)\n");
@@ -17537,7 +17537,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::iterator arg2 ;
@@ -17555,23 +17555,23 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_insert__SWIG_0(PyObject *self, P
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_insert" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_insert" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t_insert" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T_insert" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t_insert" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T_insert" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_unsigned_SS_long(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_t_insert" "', argument " "3"" of type '" "std::vector< unsigned long >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_T_insert" "', argument " "3"" of type '" "std::vector< unsigned long >::value_type""'");
   } 
   temp3 = static_cast< std::vector< unsigned long >::value_type >(val3);
   arg3 = &temp3;
@@ -17584,7 +17584,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::iterator arg2 ;
@@ -17604,28 +17604,28 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_insert__SWIG_1(PyObject *self, P
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_insert" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_insert" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t_insert" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T_insert" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< unsigned long >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_t_insert" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_longinteger_T_insert" "', argument " "2"" of type '" "std::vector< unsigned long >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_size_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_t_insert" "', argument " "3"" of type '" "std::vector< unsigned long >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_longinteger_T_insert" "', argument " "3"" of type '" "std::vector< unsigned long >::size_type""'");
   } 
   arg3 = static_cast< std::vector< unsigned long >::size_type >(val3);
   ecode4 = SWIG_AsVal_unsigned_SS_long(swig_obj[3], &val4);
   if (!SWIG_IsOK(ecode4)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode4), "in method '" "vector_longinteger_t_insert" "', argument " "4"" of type '" "std::vector< unsigned long >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode4), "in method '" "vector_longinteger_T_insert" "', argument " "4"" of type '" "std::vector< unsigned long >::value_type""'");
   } 
   temp4 = static_cast< std::vector< unsigned long >::value_type >(val4);
   arg4 = &temp4;
@@ -17637,13 +17637,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_insert(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_insert(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_t_insert", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_longinteger_T_insert", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -17659,7 +17659,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_insert(PyObject *self, PyObject
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_longinteger_t_insert__SWIG_0(self, argc, argv);
+          return _wrap_vector_longinteger_T_insert__SWIG_0(self, argc, argv);
         }
       }
     }
@@ -17683,7 +17683,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_insert(PyObject *self, PyObject
             _v = SWIG_CheckState(res);
           }
           if (_v) {
-            return _wrap_vector_longinteger_t_insert__SWIG_1(self, argc, argv);
+            return _wrap_vector_longinteger_T_insert__SWIG_1(self, argc, argv);
           }
         }
       }
@@ -17691,7 +17691,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_insert(PyObject *self, PyObject
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_t_insert'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_longinteger_T_insert'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< unsigned long >::insert(std::vector< unsigned long >::iterator,std::vector< unsigned long >::value_type const &)\n"
     "    std::vector< unsigned long >::insert(std::vector< unsigned long >::iterator,std::vector< unsigned long >::size_type,std::vector< unsigned long >::value_type const &)\n");
@@ -17699,7 +17699,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_reserve(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_reserve(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   std::vector< unsigned long >::size_type arg2 ;
@@ -17710,15 +17710,15 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_reserve(PyObject *self, PyObject
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_t_reserve", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_longinteger_T_reserve", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_reserve" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_reserve" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_t_reserve" "', argument " "2"" of type '" "std::vector< unsigned long >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_longinteger_T_reserve" "', argument " "2"" of type '" "std::vector< unsigned long >::size_type""'");
   } 
   arg2 = static_cast< std::vector< unsigned long >::size_type >(val2);
   (arg1)->reserve(arg2);
@@ -17729,7 +17729,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_longinteger_t_capacity(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_longinteger_T_capacity(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -17742,7 +17742,7 @@ SWIGINTERN PyObject *_wrap_vector_longinteger_t_capacity(PyObject *self, PyObjec
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_t_capacity" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_longinteger_T_capacity" "', argument " "1"" of type '" "std::vector< unsigned long > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   result = ((std::vector< unsigned long > const *)arg1)->capacity();
@@ -17753,7 +17753,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_delete_vector_longinteger_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_delete_vector_longinteger_T(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< unsigned long > *arg1 = (std::vector< unsigned long > *) 0 ;
   void *argp1 = 0 ;
@@ -17765,7 +17765,7 @@ SWIGINTERN PyObject *_wrap_delete_vector_longinteger_t(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_unsigned_long_t, SWIG_POINTER_DISOWN |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vector_longinteger_t" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vector_longinteger_T" "', argument " "1"" of type '" "std::vector< unsigned long > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< unsigned long > * >(argp1);
   {
@@ -17786,18 +17786,18 @@ fail:
 }
 
 
-SWIGINTERN PyObject *vector_longinteger_t_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vector_longinteger_T_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   PyObject *obj;
   if (!SWIG_Python_UnpackTuple(args, "swigregister", 1, 1, &obj)) return NULL;
   SWIG_TypeNewClientData(SWIGTYPE_p_std__vectorT_unsigned_long_t, SWIG_NewClientData(obj));
   return SWIG_Py_Void();
 }
 
-SWIGINTERN PyObject *vector_longinteger_t_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vector_longinteger_T_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   return SWIG_Python_InitShadowInstance(args);
 }
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_iterator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_iterator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   PyObject **arg2 = (PyObject **) 0 ;
@@ -17812,7 +17812,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_iterator(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_iterator" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_iterator" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = (swig::SwigPyIterator *)std_vector_Sl_std_complex_Sl_double_Sg__Sg__iterator(arg1,arg2);
@@ -17823,7 +17823,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___nonzero__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___nonzero__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -17836,7 +17836,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___nonzero__(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___nonzero__" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___nonzero__" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = (bool)std_vector_Sl_std_complex_Sl_double_Sg__Sg____nonzero__((std::vector< std::complex< double > > const *)arg1);
@@ -17847,7 +17847,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___bool__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___bool__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -17860,7 +17860,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___bool__(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___bool__" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___bool__" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = (bool)std_vector_Sl_std_complex_Sl_double_Sg__Sg____bool__((std::vector< std::complex< double > > const *)arg1);
@@ -17871,7 +17871,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___len__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___len__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -17884,7 +17884,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___len__(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___len__" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___len__" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = std_vector_Sl_std_complex_Sl_double_Sg__Sg____len__((std::vector< std::complex< double > > const *)arg1);
@@ -17895,7 +17895,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___getslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___getslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::difference_type arg2 ;
@@ -17910,20 +17910,20 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___getslice__(PyObject *self, PyObjec
   std::vector< std::complex< double >,std::allocator< std::complex< double > > > *result = 0 ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_complex_t___getslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_complex_T___getslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___getslice__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___getslice__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t___getslice__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T___getslice__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::complex< double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_t___getslice__" "', argument " "3"" of type '" "std::vector< std::complex< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_T___getslice__" "', argument " "3"" of type '" "std::vector< std::complex< double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::complex< double > >::difference_type >(val3);
   try {
@@ -17940,7 +17940,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::difference_type arg2 ;
@@ -17956,17 +17956,17 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setslice____SWIG_0(PyObject *self,
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___setslice__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___setslice__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t___setslice__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T___setslice__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::complex< double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_t___setslice__" "', argument " "3"" of type '" "std::vector< std::complex< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_T___setslice__" "', argument " "3"" of type '" "std::vector< std::complex< double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::complex< double > >::difference_type >(val3);
   try {
@@ -17983,7 +17983,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::difference_type arg2 ;
@@ -18001,27 +18001,27 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setslice____SWIG_1(PyObject *self,
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___setslice__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___setslice__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t___setslice__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T___setslice__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::complex< double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_t___setslice__" "', argument " "3"" of type '" "std::vector< std::complex< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_T___setslice__" "', argument " "3"" of type '" "std::vector< std::complex< double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::complex< double > >::difference_type >(val3);
   {
     std::vector< std::complex< double >,std::allocator< std::complex< double > > > *ptr = (std::vector< std::complex< double >,std::allocator< std::complex< double > > > *)0;
     res4 = swig::asptr(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_complex_t___setslice__" "', argument " "4"" of type '" "std::vector< std::complex< double >,std::allocator< std::complex< double > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_complex_T___setslice__" "', argument " "4"" of type '" "std::vector< std::complex< double >,std::allocator< std::complex< double > > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_complex_t___setslice__" "', argument " "4"" of type '" "std::vector< std::complex< double >,std::allocator< std::complex< double > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_complex_T___setslice__" "', argument " "4"" of type '" "std::vector< std::complex< double >,std::allocator< std::complex< double > > > const &""'"); 
     }
     arg4 = ptr;
   }
@@ -18041,13 +18041,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___setslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___setslice__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_t___setslice__", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_T___setslice__", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -18064,7 +18064,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setslice__(PyObject *self, PyObjec
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_complex_t___setslice____SWIG_0(self, argc, argv);
+          return _wrap_vector_complex_T___setslice____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -18087,7 +18087,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setslice__(PyObject *self, PyObjec
           int res = swig::asptr(argv[3], (std::vector< std::complex< double >,std::allocator< std::complex< double > > >**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vector_complex_t___setslice____SWIG_1(self, argc, argv);
+            return _wrap_vector_complex_T___setslice____SWIG_1(self, argc, argv);
           }
         }
       }
@@ -18095,7 +18095,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setslice__(PyObject *self, PyObjec
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_t___setslice__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_T___setslice__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::complex< double > >::__setslice__(std::vector< std::complex< double > >::difference_type,std::vector< std::complex< double > >::difference_type)\n"
     "    std::vector< std::complex< double > >::__setslice__(std::vector< std::complex< double > >::difference_type,std::vector< std::complex< double > >::difference_type,std::vector< std::complex< double >,std::allocator< std::complex< double > > > const &)\n");
@@ -18103,7 +18103,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___delslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___delslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::difference_type arg2 ;
@@ -18117,20 +18117,20 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___delslice__(PyObject *self, PyObjec
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_complex_t___delslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_complex_T___delslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___delslice__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___delslice__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t___delslice__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T___delslice__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::complex< double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_t___delslice__" "', argument " "3"" of type '" "std::vector< std::complex< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_T___delslice__" "', argument " "3"" of type '" "std::vector< std::complex< double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::complex< double > >::difference_type >(val3);
   try {
@@ -18147,7 +18147,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::difference_type arg2 ;
@@ -18160,12 +18160,12 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___delitem____SWIG_0(PyObject *self,
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___delitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___delitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t___delitem__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T___delitem__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::complex< double > >::difference_type >(val2);
   try {
@@ -18182,7 +18182,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -18194,12 +18194,12 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___getitem____SWIG_0(PyObject *self,
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___getitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___getitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -18217,7 +18217,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -18230,12 +18230,12 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setitem____SWIG_0(PyObject *self,
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___setitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___setitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -18243,10 +18243,10 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setitem____SWIG_0(PyObject *self,
     std::vector< std::complex< double >,std::allocator< std::complex< double > > > *ptr = (std::vector< std::complex< double >,std::allocator< std::complex< double > > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_complex_t___setitem__" "', argument " "3"" of type '" "std::vector< std::complex< double >,std::allocator< std::complex< double > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_complex_T___setitem__" "', argument " "3"" of type '" "std::vector< std::complex< double >,std::allocator< std::complex< double > > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_complex_t___setitem__" "', argument " "3"" of type '" "std::vector< std::complex< double >,std::allocator< std::complex< double > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_complex_T___setitem__" "', argument " "3"" of type '" "std::vector< std::complex< double >,std::allocator< std::complex< double > > > const &""'"); 
     }
     arg3 = ptr;
   }
@@ -18266,7 +18266,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -18277,12 +18277,12 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setitem____SWIG_1(PyObject *self,
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___setitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___setitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -18300,7 +18300,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -18311,12 +18311,12 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___delitem____SWIG_1(PyObject *self,
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___delitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___delitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -18334,13 +18334,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___delitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___delitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_t___delitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_T___delitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -18351,7 +18351,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___delitem__(PyObject *self, PyObject
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_complex_t___delitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_complex_T___delitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -18365,13 +18365,13 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___delitem__(PyObject *self, PyObject
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_complex_t___delitem____SWIG_0(self, argc, argv);
+        return _wrap_vector_complex_T___delitem____SWIG_0(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_t___delitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_T___delitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::complex< double > >::__delitem__(std::vector< std::complex< double > >::difference_type)\n"
     "    std::vector< std::complex< double > >::__delitem__(SWIGPY_SLICEOBJECT *)\n");
@@ -18379,7 +18379,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::difference_type arg2 ;
@@ -18393,12 +18393,12 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___getitem____SWIG_1(PyObject *self,
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___getitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___getitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t___getitem__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T___getitem__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::complex< double > >::difference_type >(val2);
   try {
@@ -18414,13 +18414,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___getitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___getitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_t___getitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_T___getitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -18431,7 +18431,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___getitem__(PyObject *self, PyObject
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_complex_t___getitem____SWIG_0(self, argc, argv);
+        return _wrap_vector_complex_T___getitem____SWIG_0(self, argc, argv);
       }
     }
   }
@@ -18445,13 +18445,13 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___getitem__(PyObject *self, PyObject
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_complex_t___getitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_complex_T___getitem____SWIG_1(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_t___getitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_T___getitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::complex< double > >::__getitem__(SWIGPY_SLICEOBJECT *)\n"
     "    std::vector< std::complex< double > >::__getitem__(std::vector< std::complex< double > >::difference_type) const\n");
@@ -18459,7 +18459,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::difference_type arg2 ;
@@ -18476,17 +18476,17 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setitem____SWIG_2(PyObject *self,
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t___setitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T___setitem__" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t___setitem__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T___setitem__" "', argument " "2"" of type '" "std::vector< std::complex< double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::complex< double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_std_complex_Sl_double_Sg_(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_t___setitem__" "', argument " "3"" of type '" "std::vector< std::complex< double > >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_T___setitem__" "', argument " "3"" of type '" "std::vector< std::complex< double > >::value_type""'");
   } 
   temp3 = static_cast< std::vector< std::complex< double > >::value_type >(val3);
   arg3 = &temp3;
@@ -18502,13 +18502,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t___setitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T___setitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_t___setitem__", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_T___setitem__", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -18519,7 +18519,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setitem__(PyObject *self, PyObject
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_complex_t___setitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_complex_T___setitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -18535,7 +18535,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setitem__(PyObject *self, PyObject
         int res = swig::asptr(argv[2], (std::vector< std::complex< double >,std::allocator< std::complex< double > > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vector_complex_t___setitem____SWIG_0(self, argc, argv);
+          return _wrap_vector_complex_T___setitem____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -18555,14 +18555,14 @@ SWIGINTERN PyObject *_wrap_vector_complex_t___setitem__(PyObject *self, PyObject
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_complex_t___setitem____SWIG_2(self, argc, argv);
+          return _wrap_vector_complex_T___setitem____SWIG_2(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_t___setitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_T___setitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::complex< double > >::__setitem__(SWIGPY_SLICEOBJECT *,std::vector< std::complex< double >,std::allocator< std::complex< double > > > const &)\n"
     "    std::vector< std::complex< double > >::__setitem__(SWIGPY_SLICEOBJECT *)\n"
@@ -18571,7 +18571,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_pop(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_pop(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -18584,7 +18584,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_pop(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_pop" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_pop" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   try {
@@ -18599,7 +18599,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_append(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_append(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::value_type *arg2 = 0 ;
@@ -18611,15 +18611,15 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_append(PyObject *self, PyObject *arg
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_complex_t_append", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_complex_T_append", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_append" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_append" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_std_complex_Sl_double_Sg_(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t_append" "', argument " "2"" of type '" "std::vector< std::complex< double > >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T_append" "', argument " "2"" of type '" "std::vector< std::complex< double > >::value_type""'");
   } 
   temp2 = static_cast< std::vector< std::complex< double > >::value_type >(val2);
   arg2 = &temp2;
@@ -18631,7 +18631,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_complex_t__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
+SWIGINTERN PyObject *_wrap_new_vector_complex_T__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *result = 0 ;
   
@@ -18645,7 +18645,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_complex_t__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_complex_T__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = 0 ;
   int res1 = SWIG_OLDOBJ ;
@@ -18657,10 +18657,10 @@ SWIGINTERN PyObject *_wrap_new_vector_complex_t__SWIG_1(PyObject *self, Py_ssize
     std::vector< std::complex< double >,std::allocator< std::complex< double > > > *ptr = (std::vector< std::complex< double >,std::allocator< std::complex< double > > > *)0;
     res1 = swig::asptr(swig_obj[0], &ptr);
     if (!SWIG_IsOK(res1)) {
-      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vector_complex_t" "', argument " "1"" of type '" "std::vector< std::complex< double > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vector_complex_T" "', argument " "1"" of type '" "std::vector< std::complex< double > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_complex_t" "', argument " "1"" of type '" "std::vector< std::complex< double > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_complex_T" "', argument " "1"" of type '" "std::vector< std::complex< double > > const &""'"); 
     }
     arg1 = ptr;
   }
@@ -18674,7 +18674,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_empty(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_empty(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -18687,7 +18687,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_empty(PyObject *self, PyObject *args
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_empty" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_empty" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = (bool)((std::vector< std::complex< double > > const *)arg1)->empty();
@@ -18698,7 +18698,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_size(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_size(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -18711,7 +18711,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_size(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_size" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_size" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = ((std::vector< std::complex< double > > const *)arg1)->size();
@@ -18722,7 +18722,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_swap(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_swap(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > > *arg2 = 0 ;
@@ -18733,18 +18733,18 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_swap(PyObject *self, PyObject *args)
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_complex_t_swap", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_complex_T_swap", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_swap" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_swap" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], &argp2, SWIGTYPE_p_std__vectorT_std__complexT_double_t_t,  0 );
   if (!SWIG_IsOK(res2)) {
-    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_complex_t_swap" "', argument " "2"" of type '" "std::vector< std::complex< double > > &""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_complex_T_swap" "', argument " "2"" of type '" "std::vector< std::complex< double > > &""'"); 
   }
   if (!argp2) {
-    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_complex_t_swap" "', argument " "2"" of type '" "std::vector< std::complex< double > > &""'"); 
+    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_complex_T_swap" "', argument " "2"" of type '" "std::vector< std::complex< double > > &""'"); 
   }
   arg2 = reinterpret_cast< std::vector< std::complex< double > > * >(argp2);
   (arg1)->swap(*arg2);
@@ -18755,7 +18755,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_begin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_begin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -18768,7 +18768,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_begin(PyObject *self, PyObject *args
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_begin" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_begin" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = (arg1)->begin();
@@ -18780,7 +18780,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_end(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_end(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -18793,7 +18793,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_end(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_end" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_end" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = (arg1)->end();
@@ -18805,7 +18805,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_rbegin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_rbegin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -18818,7 +18818,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_rbegin(PyObject *self, PyObject *arg
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_rbegin" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_rbegin" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = (arg1)->rbegin();
@@ -18830,7 +18830,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_rend(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_rend(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -18843,7 +18843,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_rend(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_rend" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_rend" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = (arg1)->rend();
@@ -18855,7 +18855,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_clear(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_clear(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -18867,7 +18867,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_clear(PyObject *self, PyObject *args
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_clear" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_clear" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   (arg1)->clear();
@@ -18878,7 +18878,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_get_allocator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_get_allocator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -18891,7 +18891,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_get_allocator(PyObject *self, PyObje
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_get_allocator" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_get_allocator" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = ((std::vector< std::complex< double > > const *)arg1)->get_allocator();
@@ -18902,7 +18902,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_complex_t__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_complex_T__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > >::size_type arg1 ;
   size_t val1 ;
@@ -18913,7 +18913,7 @@ SWIGINTERN PyObject *_wrap_new_vector_complex_t__SWIG_2(PyObject *self, Py_ssize
   if ((nobjs < 1) || (nobjs > 1)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_complex_t" "', argument " "1"" of type '" "std::vector< std::complex< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_complex_T" "', argument " "1"" of type '" "std::vector< std::complex< double > >::size_type""'");
   } 
   arg1 = static_cast< std::vector< std::complex< double > >::size_type >(val1);
   result = (std::vector< std::complex< double > > *)new std::vector< std::complex< double > >(arg1);
@@ -18924,7 +18924,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_pop_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_pop_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -18936,7 +18936,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_pop_back(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_pop_back" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_pop_back" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   (arg1)->pop_back();
@@ -18947,7 +18947,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::size_type arg2 ;
@@ -18960,12 +18960,12 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_resize__SWIG_0(PyObject *self, Py_ss
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_resize" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_resize" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t_resize" "', argument " "2"" of type '" "std::vector< std::complex< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T_resize" "', argument " "2"" of type '" "std::vector< std::complex< double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::complex< double > >::size_type >(val2);
   (arg1)->resize(arg2);
@@ -18976,7 +18976,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::iterator arg2 ;
@@ -18990,18 +18990,18 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_erase__SWIG_0(PyObject *self, Py_ssi
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_erase" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_erase" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t_erase" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T_erase" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t_erase" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T_erase" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
     }
   }
   result = std_vector_Sl_std_complex_Sl_double_Sg__Sg__erase__SWIG_0(arg1,SWIG_STD_MOVE(arg2));
@@ -19013,7 +19013,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::iterator arg2 ;
@@ -19030,29 +19030,29 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_erase__SWIG_1(PyObject *self, Py_ssi
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_erase" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_erase" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t_erase" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T_erase" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t_erase" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T_erase" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
     }
   }
   res3 = SWIG_ConvertPtr(swig_obj[2], SWIG_as_voidptrptr(&iter3), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res3) || !iter3) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t_erase" "', argument " "3"" of type '" "std::vector< std::complex< double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T_erase" "', argument " "3"" of type '" "std::vector< std::complex< double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *>(iter3);
     if (iter_t) {
       arg3 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t_erase" "', argument " "3"" of type '" "std::vector< std::complex< double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T_erase" "', argument " "3"" of type '" "std::vector< std::complex< double > >::iterator""'");
     }
   }
   result = std_vector_Sl_std_complex_Sl_double_Sg__Sg__erase__SWIG_1(arg1,SWIG_STD_MOVE(arg2),SWIG_STD_MOVE(arg3));
@@ -19064,13 +19064,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_erase(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_erase(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_t_erase", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_T_erase", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -19081,7 +19081,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_erase(PyObject *self, PyObject *args
       int res = SWIG_ConvertPtr(argv[1], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
       _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *>(iter) != 0));
       if (_v) {
-        return _wrap_vector_complex_t_erase__SWIG_0(self, argc, argv);
+        return _wrap_vector_complex_T_erase__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -19098,14 +19098,14 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_erase(PyObject *self, PyObject *args
         int res = SWIG_ConvertPtr(argv[2], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
         _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *>(iter) != 0));
         if (_v) {
-          return _wrap_vector_complex_t_erase__SWIG_1(self, argc, argv);
+          return _wrap_vector_complex_T_erase__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_t_erase'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_T_erase'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::complex< double > >::erase(std::vector< std::complex< double > >::iterator)\n"
     "    std::vector< std::complex< double > >::erase(std::vector< std::complex< double > >::iterator,std::vector< std::complex< double > >::iterator)\n");
@@ -19113,7 +19113,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_complex_t__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_complex_T__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > >::size_type arg1 ;
   std::vector< std::complex< double > >::value_type *arg2 = 0 ;
@@ -19128,12 +19128,12 @@ SWIGINTERN PyObject *_wrap_new_vector_complex_t__SWIG_3(PyObject *self, Py_ssize
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_complex_t" "', argument " "1"" of type '" "std::vector< std::complex< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_complex_T" "', argument " "1"" of type '" "std::vector< std::complex< double > >::size_type""'");
   } 
   arg1 = static_cast< std::vector< std::complex< double > >::size_type >(val1);
   ecode2 = SWIG_AsVal_std_complex_Sl_double_Sg_(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "new_vector_complex_t" "', argument " "2"" of type '" "std::vector< std::complex< double > >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "new_vector_complex_T" "', argument " "2"" of type '" "std::vector< std::complex< double > >::value_type""'");
   } 
   temp2 = static_cast< std::vector< std::complex< double > >::value_type >(val2);
   arg2 = &temp2;
@@ -19145,16 +19145,16 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_complex_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_new_vector_complex_T(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vector_complex_t", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vector_complex_T", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 0) {
-    return _wrap_new_vector_complex_t__SWIG_0(self, argc, argv);
+    return _wrap_new_vector_complex_T__SWIG_0(self, argc, argv);
   }
   if (argc == 1) {
     int _v = 0;
@@ -19163,7 +19163,7 @@ SWIGINTERN PyObject *_wrap_new_vector_complex_t(PyObject *self, PyObject *args)
       _v = SWIG_CheckState(res);
     }
     if (_v) {
-      return _wrap_new_vector_complex_t__SWIG_2(self, argc, argv);
+      return _wrap_new_vector_complex_T__SWIG_2(self, argc, argv);
     }
   }
   if (argc == 1) {
@@ -19171,7 +19171,7 @@ SWIGINTERN PyObject *_wrap_new_vector_complex_t(PyObject *self, PyObject *args)
     int res = swig::asptr(argv[0], (std::vector< std::complex< double >,std::allocator< std::complex< double > > >**)(0));
     _v = SWIG_CheckState(res);
     if (_v) {
-      return _wrap_new_vector_complex_t__SWIG_1(self, argc, argv);
+      return _wrap_new_vector_complex_T__SWIG_1(self, argc, argv);
     }
   }
   if (argc == 2) {
@@ -19186,13 +19186,13 @@ SWIGINTERN PyObject *_wrap_new_vector_complex_t(PyObject *self, PyObject *args)
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_new_vector_complex_t__SWIG_3(self, argc, argv);
+        return _wrap_new_vector_complex_T__SWIG_3(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vector_complex_t'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vector_complex_T'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::complex< double > >::vector()\n"
     "    std::vector< std::complex< double > >::vector(std::vector< std::complex< double > > const &)\n"
@@ -19202,7 +19202,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_push_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_push_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::value_type *arg2 = 0 ;
@@ -19214,15 +19214,15 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_push_back(PyObject *self, PyObject *
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_complex_t_push_back", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_complex_T_push_back", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_push_back" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_push_back" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_std_complex_Sl_double_Sg_(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t_push_back" "', argument " "2"" of type '" "std::vector< std::complex< double > >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T_push_back" "', argument " "2"" of type '" "std::vector< std::complex< double > >::value_type""'");
   } 
   temp2 = static_cast< std::vector< std::complex< double > >::value_type >(val2);
   arg2 = &temp2;
@@ -19234,7 +19234,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_front(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_front(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -19247,7 +19247,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_front(PyObject *self, PyObject *args
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_front" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_front" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = (std::vector< std::complex< double > >::value_type *) &((std::vector< std::complex< double > > const *)arg1)->front();
@@ -19259,7 +19259,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -19272,7 +19272,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_back(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_back" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_back" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = (std::vector< std::complex< double > >::value_type *) &((std::vector< std::complex< double > > const *)arg1)->back();
@@ -19284,7 +19284,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_assign(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_assign(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::size_type arg2 ;
@@ -19299,20 +19299,20 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_assign(PyObject *self, PyObject *arg
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_complex_t_assign", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_complex_T_assign", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_assign" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_assign" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t_assign" "', argument " "2"" of type '" "std::vector< std::complex< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T_assign" "', argument " "2"" of type '" "std::vector< std::complex< double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::complex< double > >::size_type >(val2);
   ecode3 = SWIG_AsVal_std_complex_Sl_double_Sg_(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_t_assign" "', argument " "3"" of type '" "std::vector< std::complex< double > >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_T_assign" "', argument " "3"" of type '" "std::vector< std::complex< double > >::value_type""'");
   } 
   temp3 = static_cast< std::vector< std::complex< double > >::value_type >(val3);
   arg3 = &temp3;
@@ -19324,7 +19324,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::size_type arg2 ;
@@ -19341,17 +19341,17 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_resize__SWIG_1(PyObject *self, Py_ss
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_resize" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_resize" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t_resize" "', argument " "2"" of type '" "std::vector< std::complex< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T_resize" "', argument " "2"" of type '" "std::vector< std::complex< double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::complex< double > >::size_type >(val2);
   ecode3 = SWIG_AsVal_std_complex_Sl_double_Sg_(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_t_resize" "', argument " "3"" of type '" "std::vector< std::complex< double > >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_T_resize" "', argument " "3"" of type '" "std::vector< std::complex< double > >::value_type""'");
   } 
   temp3 = static_cast< std::vector< std::complex< double > >::value_type >(val3);
   arg3 = &temp3;
@@ -19363,13 +19363,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_resize(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_resize(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_t_resize", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_T_resize", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -19381,7 +19381,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_resize(PyObject *self, PyObject *arg
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_complex_t_resize__SWIG_0(self, argc, argv);
+        return _wrap_vector_complex_T_resize__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -19400,14 +19400,14 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_resize(PyObject *self, PyObject *arg
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_complex_t_resize__SWIG_1(self, argc, argv);
+          return _wrap_vector_complex_T_resize__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_t_resize'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_T_resize'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::complex< double > >::resize(std::vector< std::complex< double > >::size_type)\n"
     "    std::vector< std::complex< double > >::resize(std::vector< std::complex< double > >::size_type,std::vector< std::complex< double > >::value_type const &)\n");
@@ -19415,7 +19415,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::iterator arg2 ;
@@ -19433,23 +19433,23 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_insert__SWIG_0(PyObject *self, Py_ss
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_insert" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_insert" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t_insert" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T_insert" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t_insert" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T_insert" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_std_complex_Sl_double_Sg_(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_t_insert" "', argument " "3"" of type '" "std::vector< std::complex< double > >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_T_insert" "', argument " "3"" of type '" "std::vector< std::complex< double > >::value_type""'");
   } 
   temp3 = static_cast< std::vector< std::complex< double > >::value_type >(val3);
   arg3 = &temp3;
@@ -19462,7 +19462,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::iterator arg2 ;
@@ -19482,28 +19482,28 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_insert__SWIG_1(PyObject *self, Py_ss
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_insert" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_insert" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t_insert" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T_insert" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::complex< double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_t_insert" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_complex_T_insert" "', argument " "2"" of type '" "std::vector< std::complex< double > >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_size_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_t_insert" "', argument " "3"" of type '" "std::vector< std::complex< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_complex_T_insert" "', argument " "3"" of type '" "std::vector< std::complex< double > >::size_type""'");
   } 
   arg3 = static_cast< std::vector< std::complex< double > >::size_type >(val3);
   ecode4 = SWIG_AsVal_std_complex_Sl_double_Sg_(swig_obj[3], &val4);
   if (!SWIG_IsOK(ecode4)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode4), "in method '" "vector_complex_t_insert" "', argument " "4"" of type '" "std::vector< std::complex< double > >::value_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode4), "in method '" "vector_complex_T_insert" "', argument " "4"" of type '" "std::vector< std::complex< double > >::value_type""'");
   } 
   temp4 = static_cast< std::vector< std::complex< double > >::value_type >(val4);
   arg4 = &temp4;
@@ -19515,13 +19515,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_insert(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_insert(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_t_insert", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_complex_T_insert", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -19537,7 +19537,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_insert(PyObject *self, PyObject *arg
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_complex_t_insert__SWIG_0(self, argc, argv);
+          return _wrap_vector_complex_T_insert__SWIG_0(self, argc, argv);
         }
       }
     }
@@ -19561,7 +19561,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_insert(PyObject *self, PyObject *arg
             _v = SWIG_CheckState(res);
           }
           if (_v) {
-            return _wrap_vector_complex_t_insert__SWIG_1(self, argc, argv);
+            return _wrap_vector_complex_T_insert__SWIG_1(self, argc, argv);
           }
         }
       }
@@ -19569,7 +19569,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_insert(PyObject *self, PyObject *arg
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_t_insert'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_complex_T_insert'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::complex< double > >::insert(std::vector< std::complex< double > >::iterator,std::vector< std::complex< double > >::value_type const &)\n"
     "    std::vector< std::complex< double > >::insert(std::vector< std::complex< double > >::iterator,std::vector< std::complex< double > >::size_type,std::vector< std::complex< double > >::value_type const &)\n");
@@ -19577,7 +19577,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_reserve(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_reserve(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   std::vector< std::complex< double > >::size_type arg2 ;
@@ -19588,15 +19588,15 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_reserve(PyObject *self, PyObject *ar
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_complex_t_reserve", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_complex_T_reserve", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_reserve" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_reserve" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_t_reserve" "', argument " "2"" of type '" "std::vector< std::complex< double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_complex_T_reserve" "', argument " "2"" of type '" "std::vector< std::complex< double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::complex< double > >::size_type >(val2);
   (arg1)->reserve(arg2);
@@ -19607,7 +19607,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_complex_t_capacity(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_complex_T_capacity(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -19620,7 +19620,7 @@ SWIGINTERN PyObject *_wrap_vector_complex_t_capacity(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_t_capacity" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_complex_T_capacity" "', argument " "1"" of type '" "std::vector< std::complex< double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   result = ((std::vector< std::complex< double > > const *)arg1)->capacity();
@@ -19631,7 +19631,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_delete_vector_complex_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_delete_vector_complex_T(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::complex< double > > *arg1 = (std::vector< std::complex< double > > *) 0 ;
   void *argp1 = 0 ;
@@ -19643,7 +19643,7 @@ SWIGINTERN PyObject *_wrap_delete_vector_complex_t(PyObject *self, PyObject *arg
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, SWIG_POINTER_DISOWN |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vector_complex_t" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vector_complex_T" "', argument " "1"" of type '" "std::vector< std::complex< double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::complex< double > > * >(argp1);
   {
@@ -19664,18 +19664,18 @@ fail:
 }
 
 
-SWIGINTERN PyObject *vector_complex_t_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vector_complex_T_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   PyObject *obj;
   if (!SWIG_Python_UnpackTuple(args, "swigregister", 1, 1, &obj)) return NULL;
   SWIG_TypeNewClientData(SWIGTYPE_p_std__vectorT_std__complexT_double_t_t, SWIG_NewClientData(obj));
   return SWIG_Py_Void();
 }
 
-SWIGINTERN PyObject *vector_complex_t_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vector_complex_T_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   return SWIG_Python_InitShadowInstance(args);
 }
 
-SWIGINTERN PyObject *_wrap_vector_string_t_iterator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_iterator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   PyObject **arg2 = (PyObject **) 0 ;
@@ -19690,7 +19690,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_iterator(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_iterator" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_iterator" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = (swig::SwigPyIterator *)std_vector_Sl_std_string_Sg__iterator(arg1,arg2);
@@ -19701,7 +19701,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___nonzero__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T___nonzero__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -19714,7 +19714,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t___nonzero__(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___nonzero__" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___nonzero__" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = (bool)std_vector_Sl_std_string_Sg____nonzero__((std::vector< std::string > const *)arg1);
@@ -19725,7 +19725,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___bool__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T___bool__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -19738,7 +19738,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t___bool__(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___bool__" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___bool__" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = (bool)std_vector_Sl_std_string_Sg____bool__((std::vector< std::string > const *)arg1);
@@ -19749,7 +19749,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___len__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T___len__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -19762,7 +19762,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t___len__(PyObject *self, PyObject *arg
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___len__" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___len__" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = std_vector_Sl_std_string_Sg____len__((std::vector< std::string > const *)arg1);
@@ -19773,7 +19773,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___getslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T___getslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::difference_type arg2 ;
@@ -19788,20 +19788,20 @@ SWIGINTERN PyObject *_wrap_vector_string_t___getslice__(PyObject *self, PyObject
   std::vector< std::string,std::allocator< std::string > > *result = 0 ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_string_t___getslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_string_T___getslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___getslice__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___getslice__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_t___getslice__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_T___getslice__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::string >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_string_t___getslice__" "', argument " "3"" of type '" "std::vector< std::string >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_string_T___getslice__" "', argument " "3"" of type '" "std::vector< std::string >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::string >::difference_type >(val3);
   try {
@@ -19818,7 +19818,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::difference_type arg2 ;
@@ -19834,17 +19834,17 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setslice____SWIG_0(PyObject *self,
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___setslice__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___setslice__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_t___setslice__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_T___setslice__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::string >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_string_t___setslice__" "', argument " "3"" of type '" "std::vector< std::string >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_string_T___setslice__" "', argument " "3"" of type '" "std::vector< std::string >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::string >::difference_type >(val3);
   try {
@@ -19861,7 +19861,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::difference_type arg2 ;
@@ -19879,27 +19879,27 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setslice____SWIG_1(PyObject *self,
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___setslice__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___setslice__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_t___setslice__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_T___setslice__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::string >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_string_t___setslice__" "', argument " "3"" of type '" "std::vector< std::string >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_string_T___setslice__" "', argument " "3"" of type '" "std::vector< std::string >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::string >::difference_type >(val3);
   {
     std::vector< std::string,std::allocator< std::string > > *ptr = (std::vector< std::string,std::allocator< std::string > > *)0;
     res4 = swig::asptr(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_string_t___setslice__" "', argument " "4"" of type '" "std::vector< std::string,std::allocator< std::string > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_string_T___setslice__" "', argument " "4"" of type '" "std::vector< std::string,std::allocator< std::string > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_t___setslice__" "', argument " "4"" of type '" "std::vector< std::string,std::allocator< std::string > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_T___setslice__" "', argument " "4"" of type '" "std::vector< std::string,std::allocator< std::string > > const &""'"); 
     }
     arg4 = ptr;
   }
@@ -19919,13 +19919,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___setslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T___setslice__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_t___setslice__", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_T___setslice__", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -19942,7 +19942,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setslice__(PyObject *self, PyObject
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_string_t___setslice____SWIG_0(self, argc, argv);
+          return _wrap_vector_string_T___setslice____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -19965,7 +19965,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setslice__(PyObject *self, PyObject
           int res = swig::asptr(argv[3], (std::vector< std::string,std::allocator< std::string > >**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vector_string_t___setslice____SWIG_1(self, argc, argv);
+            return _wrap_vector_string_T___setslice____SWIG_1(self, argc, argv);
           }
         }
       }
@@ -19973,7 +19973,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setslice__(PyObject *self, PyObject
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_t___setslice__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_T___setslice__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::string >::__setslice__(std::vector< std::string >::difference_type,std::vector< std::string >::difference_type)\n"
     "    std::vector< std::string >::__setslice__(std::vector< std::string >::difference_type,std::vector< std::string >::difference_type,std::vector< std::string,std::allocator< std::string > > const &)\n");
@@ -19981,7 +19981,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___delslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T___delslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::difference_type arg2 ;
@@ -19995,20 +19995,20 @@ SWIGINTERN PyObject *_wrap_vector_string_t___delslice__(PyObject *self, PyObject
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_string_t___delslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_string_T___delslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___delslice__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___delslice__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_t___delslice__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_T___delslice__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::string >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_string_t___delslice__" "', argument " "3"" of type '" "std::vector< std::string >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_string_T___delslice__" "', argument " "3"" of type '" "std::vector< std::string >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::string >::difference_type >(val3);
   try {
@@ -20025,7 +20025,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::difference_type arg2 ;
@@ -20038,12 +20038,12 @@ SWIGINTERN PyObject *_wrap_vector_string_t___delitem____SWIG_0(PyObject *self, P
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___delitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___delitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_t___delitem__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_T___delitem__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::string >::difference_type >(val2);
   try {
@@ -20060,7 +20060,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -20072,12 +20072,12 @@ SWIGINTERN PyObject *_wrap_vector_string_t___getitem____SWIG_0(PyObject *self, P
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___getitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___getitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -20095,7 +20095,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -20108,12 +20108,12 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setitem____SWIG_0(PyObject *self, P
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___setitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___setitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -20121,10 +20121,10 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setitem____SWIG_0(PyObject *self, P
     std::vector< std::string,std::allocator< std::string > > *ptr = (std::vector< std::string,std::allocator< std::string > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_string_t___setitem__" "', argument " "3"" of type '" "std::vector< std::string,std::allocator< std::string > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_string_T___setitem__" "', argument " "3"" of type '" "std::vector< std::string,std::allocator< std::string > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_t___setitem__" "', argument " "3"" of type '" "std::vector< std::string,std::allocator< std::string > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_T___setitem__" "', argument " "3"" of type '" "std::vector< std::string,std::allocator< std::string > > const &""'"); 
     }
     arg3 = ptr;
   }
@@ -20144,7 +20144,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -20155,12 +20155,12 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setitem____SWIG_1(PyObject *self, P
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___setitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___setitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -20178,7 +20178,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -20189,12 +20189,12 @@ SWIGINTERN PyObject *_wrap_vector_string_t___delitem____SWIG_1(PyObject *self, P
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___delitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___delitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -20212,13 +20212,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___delitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T___delitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_t___delitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_T___delitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -20229,7 +20229,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t___delitem__(PyObject *self, PyObject
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_string_t___delitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_string_T___delitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -20243,13 +20243,13 @@ SWIGINTERN PyObject *_wrap_vector_string_t___delitem__(PyObject *self, PyObject
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_string_t___delitem____SWIG_0(self, argc, argv);
+        return _wrap_vector_string_T___delitem____SWIG_0(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_t___delitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_T___delitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::string >::__delitem__(std::vector< std::string >::difference_type)\n"
     "    std::vector< std::string >::__delitem__(SWIGPY_SLICEOBJECT *)\n");
@@ -20257,7 +20257,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::difference_type arg2 ;
@@ -20271,12 +20271,12 @@ SWIGINTERN PyObject *_wrap_vector_string_t___getitem____SWIG_1(PyObject *self, P
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___getitem__" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___getitem__" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_t___getitem__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_T___getitem__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::string >::difference_type >(val2);
   try {
@@ -20292,13 +20292,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___getitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T___getitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_t___getitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_T___getitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -20309,7 +20309,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t___getitem__(PyObject *self, PyObject
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_string_t___getitem____SWIG_0(self, argc, argv);
+        return _wrap_vector_string_T___getitem____SWIG_0(self, argc, argv);
       }
     }
   }
@@ -20323,13 +20323,13 @@ SWIGINTERN PyObject *_wrap_vector_string_t___getitem__(PyObject *self, PyObject
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_string_t___getitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_string_T___getitem____SWIG_1(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_t___getitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_T___getitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::string >::__getitem__(SWIGPY_SLICEOBJECT *)\n"
     "    std::vector< std::string >::__getitem__(std::vector< std::string >::difference_type) const\n");
@@ -20337,7 +20337,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::difference_type arg2 ;
@@ -20352,22 +20352,22 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setitem____SWIG_2(PyObject *self, P
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t___setitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T___setitem__" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_t___setitem__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_T___setitem__" "', argument " "2"" of type '" "std::vector< std::string >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::string >::difference_type >(val2);
   {
     std::string *ptr = (std::string *)0;
     res3 = SWIG_AsPtr_std_string(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_string_t___setitem__" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_string_T___setitem__" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_t___setitem__" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_T___setitem__" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -20385,13 +20385,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t___setitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T___setitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_t___setitem__", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_T___setitem__", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -20402,7 +20402,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setitem__(PyObject *self, PyObject
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_string_t___setitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_string_T___setitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -20418,7 +20418,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setitem__(PyObject *self, PyObject
         int res = swig::asptr(argv[2], (std::vector< std::string,std::allocator< std::string > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vector_string_t___setitem____SWIG_0(self, argc, argv);
+          return _wrap_vector_string_T___setitem____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -20436,14 +20436,14 @@ SWIGINTERN PyObject *_wrap_vector_string_t___setitem__(PyObject *self, PyObject
         int res = SWIG_AsPtr_std_string(argv[2], (std::string**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vector_string_t___setitem____SWIG_2(self, argc, argv);
+          return _wrap_vector_string_T___setitem____SWIG_2(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_t___setitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_T___setitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::string >::__setitem__(SWIGPY_SLICEOBJECT *,std::vector< std::string,std::allocator< std::string > > const &)\n"
     "    std::vector< std::string >::__setitem__(SWIGPY_SLICEOBJECT *)\n"
@@ -20452,7 +20452,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_pop(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_pop(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -20465,7 +20465,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_pop(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_pop" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_pop" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   try {
@@ -20480,7 +20480,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_append(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_append(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::value_type *arg2 = 0 ;
@@ -20490,20 +20490,20 @@ SWIGINTERN PyObject *_wrap_vector_string_t_append(PyObject *self, PyObject *args
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_string_t_append", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_string_T_append", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_append" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_append" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_string_t_append" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_string_T_append" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_t_append" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_T_append" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -20517,7 +20517,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_string_t__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
+SWIGINTERN PyObject *_wrap_new_vector_string_T__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
   PyObject *resultobj = 0;
   std::vector< std::string > *result = 0 ;
   
@@ -20531,7 +20531,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_string_t__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_string_T__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = 0 ;
   int res1 = SWIG_OLDOBJ ;
@@ -20543,10 +20543,10 @@ SWIGINTERN PyObject *_wrap_new_vector_string_t__SWIG_1(PyObject *self, Py_ssize_
     std::vector< std::string,std::allocator< std::string > > *ptr = (std::vector< std::string,std::allocator< std::string > > *)0;
     res1 = swig::asptr(swig_obj[0], &ptr);
     if (!SWIG_IsOK(res1)) {
-      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vector_string_t" "', argument " "1"" of type '" "std::vector< std::string > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vector_string_T" "', argument " "1"" of type '" "std::vector< std::string > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_string_t" "', argument " "1"" of type '" "std::vector< std::string > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_string_T" "', argument " "1"" of type '" "std::vector< std::string > const &""'"); 
     }
     arg1 = ptr;
   }
@@ -20560,7 +20560,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_empty(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_empty(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -20573,7 +20573,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_empty(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_empty" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_empty" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = (bool)((std::vector< std::string > const *)arg1)->empty();
@@ -20584,7 +20584,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_size(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_size(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -20597,7 +20597,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_size(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_size" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_size" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = ((std::vector< std::string > const *)arg1)->size();
@@ -20608,7 +20608,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_swap(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_swap(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string > *arg2 = 0 ;
@@ -20619,18 +20619,18 @@ SWIGINTERN PyObject *_wrap_vector_string_t_swap(PyObject *self, PyObject *args)
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_string_t_swap", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_string_T_swap", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_swap" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_swap" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], &argp2, SWIGTYPE_p_std__vectorT_std__string_t,  0 );
   if (!SWIG_IsOK(res2)) {
-    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_string_t_swap" "', argument " "2"" of type '" "std::vector< std::string > &""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_string_T_swap" "', argument " "2"" of type '" "std::vector< std::string > &""'"); 
   }
   if (!argp2) {
-    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_t_swap" "', argument " "2"" of type '" "std::vector< std::string > &""'"); 
+    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_T_swap" "', argument " "2"" of type '" "std::vector< std::string > &""'"); 
   }
   arg2 = reinterpret_cast< std::vector< std::string > * >(argp2);
   (arg1)->swap(*arg2);
@@ -20641,7 +20641,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_begin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_begin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -20654,7 +20654,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_begin(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_begin" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_begin" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = (arg1)->begin();
@@ -20666,7 +20666,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_end(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_end(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -20679,7 +20679,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_end(PyObject *self, PyObject *args) {
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_end" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_end" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = (arg1)->end();
@@ -20691,7 +20691,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_rbegin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_rbegin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -20704,7 +20704,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_rbegin(PyObject *self, PyObject *args
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_rbegin" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_rbegin" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = (arg1)->rbegin();
@@ -20716,7 +20716,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_rend(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_rend(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -20729,7 +20729,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_rend(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_rend" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_rend" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = (arg1)->rend();
@@ -20741,7 +20741,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_clear(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_clear(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -20753,7 +20753,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_clear(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_clear" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_clear" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   (arg1)->clear();
@@ -20764,7 +20764,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_get_allocator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_get_allocator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -20777,7 +20777,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_get_allocator(PyObject *self, PyObjec
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_get_allocator" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_get_allocator" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = ((std::vector< std::string > const *)arg1)->get_allocator();
@@ -20788,7 +20788,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_string_t__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_string_T__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string >::size_type arg1 ;
   size_t val1 ;
@@ -20799,7 +20799,7 @@ SWIGINTERN PyObject *_wrap_new_vector_string_t__SWIG_2(PyObject *self, Py_ssize_
   if ((nobjs < 1) || (nobjs > 1)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_string_t" "', argument " "1"" of type '" "std::vector< std::string >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_string_T" "', argument " "1"" of type '" "std::vector< std::string >::size_type""'");
   } 
   arg1 = static_cast< std::vector< std::string >::size_type >(val1);
   result = (std::vector< std::string > *)new std::vector< std::string >(arg1);
@@ -20810,7 +20810,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_pop_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_pop_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -20822,7 +20822,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_pop_back(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_pop_back" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_pop_back" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   (arg1)->pop_back();
@@ -20833,7 +20833,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::size_type arg2 ;
@@ -20846,12 +20846,12 @@ SWIGINTERN PyObject *_wrap_vector_string_t_resize__SWIG_0(PyObject *self, Py_ssi
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_resize" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_resize" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_t_resize" "', argument " "2"" of type '" "std::vector< std::string >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_T_resize" "', argument " "2"" of type '" "std::vector< std::string >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::string >::size_type >(val2);
   (arg1)->resize(arg2);
@@ -20862,7 +20862,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::iterator arg2 ;
@@ -20876,18 +20876,18 @@ SWIGINTERN PyObject *_wrap_vector_string_t_erase__SWIG_0(PyObject *self, Py_ssiz
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_erase" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_erase" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t_erase" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T_erase" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::string >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::string >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t_erase" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T_erase" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
     }
   }
   result = std_vector_Sl_std_string_Sg__erase__SWIG_0(arg1,SWIG_STD_MOVE(arg2));
@@ -20899,7 +20899,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::iterator arg2 ;
@@ -20916,29 +20916,29 @@ SWIGINTERN PyObject *_wrap_vector_string_t_erase__SWIG_1(PyObject *self, Py_ssiz
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_erase" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_erase" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t_erase" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T_erase" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::string >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::string >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t_erase" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T_erase" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
     }
   }
   res3 = SWIG_ConvertPtr(swig_obj[2], SWIG_as_voidptrptr(&iter3), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res3) || !iter3) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t_erase" "', argument " "3"" of type '" "std::vector< std::string >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T_erase" "', argument " "3"" of type '" "std::vector< std::string >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::string >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::string >::iterator > *>(iter3);
     if (iter_t) {
       arg3 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t_erase" "', argument " "3"" of type '" "std::vector< std::string >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T_erase" "', argument " "3"" of type '" "std::vector< std::string >::iterator""'");
     }
   }
   result = std_vector_Sl_std_string_Sg__erase__SWIG_1(arg1,SWIG_STD_MOVE(arg2),SWIG_STD_MOVE(arg3));
@@ -20950,13 +20950,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_erase(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_erase(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_t_erase", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_T_erase", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -20967,7 +20967,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_erase(PyObject *self, PyObject *args)
       int res = SWIG_ConvertPtr(argv[1], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
       _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< std::string >::iterator > *>(iter) != 0));
       if (_v) {
-        return _wrap_vector_string_t_erase__SWIG_0(self, argc, argv);
+        return _wrap_vector_string_T_erase__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -20984,14 +20984,14 @@ SWIGINTERN PyObject *_wrap_vector_string_t_erase(PyObject *self, PyObject *args)
         int res = SWIG_ConvertPtr(argv[2], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
         _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< std::string >::iterator > *>(iter) != 0));
         if (_v) {
-          return _wrap_vector_string_t_erase__SWIG_1(self, argc, argv);
+          return _wrap_vector_string_T_erase__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_t_erase'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_T_erase'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::string >::erase(std::vector< std::string >::iterator)\n"
     "    std::vector< std::string >::erase(std::vector< std::string >::iterator,std::vector< std::string >::iterator)\n");
@@ -20999,7 +20999,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_string_t__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_string_T__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string >::size_type arg1 ;
   std::vector< std::string >::value_type *arg2 = 0 ;
@@ -21012,17 +21012,17 @@ SWIGINTERN PyObject *_wrap_new_vector_string_t__SWIG_3(PyObject *self, Py_ssize_
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_string_t" "', argument " "1"" of type '" "std::vector< std::string >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_string_T" "', argument " "1"" of type '" "std::vector< std::string >::size_type""'");
   } 
   arg1 = static_cast< std::vector< std::string >::size_type >(val1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "new_vector_string_t" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "new_vector_string_T" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_string_t" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_string_T" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -21036,16 +21036,16 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_string_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_new_vector_string_T(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vector_string_t", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vector_string_T", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 0) {
-    return _wrap_new_vector_string_t__SWIG_0(self, argc, argv);
+    return _wrap_new_vector_string_T__SWIG_0(self, argc, argv);
   }
   if (argc == 1) {
     int _v = 0;
@@ -21054,7 +21054,7 @@ SWIGINTERN PyObject *_wrap_new_vector_string_t(PyObject *self, PyObject *args) {
       _v = SWIG_CheckState(res);
     }
     if (_v) {
-      return _wrap_new_vector_string_t__SWIG_2(self, argc, argv);
+      return _wrap_new_vector_string_T__SWIG_2(self, argc, argv);
     }
   }
   if (argc == 1) {
@@ -21062,7 +21062,7 @@ SWIGINTERN PyObject *_wrap_new_vector_string_t(PyObject *self, PyObject *args) {
     int res = swig::asptr(argv[0], (std::vector< std::string,std::allocator< std::string > >**)(0));
     _v = SWIG_CheckState(res);
     if (_v) {
-      return _wrap_new_vector_string_t__SWIG_1(self, argc, argv);
+      return _wrap_new_vector_string_T__SWIG_1(self, argc, argv);
     }
   }
   if (argc == 2) {
@@ -21075,13 +21075,13 @@ SWIGINTERN PyObject *_wrap_new_vector_string_t(PyObject *self, PyObject *args) {
       int res = SWIG_AsPtr_std_string(argv[1], (std::string**)(0));
       _v = SWIG_CheckState(res);
       if (_v) {
-        return _wrap_new_vector_string_t__SWIG_3(self, argc, argv);
+        return _wrap_new_vector_string_T__SWIG_3(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vector_string_t'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vector_string_T'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::string >::vector()\n"
     "    std::vector< std::string >::vector(std::vector< std::string > const &)\n"
@@ -21091,7 +21091,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_push_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_push_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::value_type *arg2 = 0 ;
@@ -21101,20 +21101,20 @@ SWIGINTERN PyObject *_wrap_vector_string_t_push_back(PyObject *self, PyObject *a
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_string_t_push_back", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_string_T_push_back", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_push_back" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_push_back" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_string_t_push_back" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_string_T_push_back" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_t_push_back" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_T_push_back" "', argument " "2"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -21128,7 +21128,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_front(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_front(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -21141,7 +21141,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_front(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_front" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_front" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = (std::vector< std::string >::value_type *) &((std::vector< std::string > const *)arg1)->front();
@@ -21153,7 +21153,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -21166,7 +21166,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_back(PyObject *self, PyObject *args)
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_back" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_back" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = (std::vector< std::string >::value_type *) &((std::vector< std::string > const *)arg1)->back();
@@ -21178,7 +21178,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_assign(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_assign(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::size_type arg2 ;
@@ -21191,25 +21191,25 @@ SWIGINTERN PyObject *_wrap_vector_string_t_assign(PyObject *self, PyObject *args
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_string_t_assign", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_string_T_assign", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_assign" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_assign" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_t_assign" "', argument " "2"" of type '" "std::vector< std::string >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_T_assign" "', argument " "2"" of type '" "std::vector< std::string >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::string >::size_type >(val2);
   {
     std::string *ptr = (std::string *)0;
     res3 = SWIG_AsPtr_std_string(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_string_t_assign" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_string_T_assign" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_t_assign" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_T_assign" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -21223,7 +21223,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::size_type arg2 ;
@@ -21238,22 +21238,22 @@ SWIGINTERN PyObject *_wrap_vector_string_t_resize__SWIG_1(PyObject *self, Py_ssi
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_resize" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_resize" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_t_resize" "', argument " "2"" of type '" "std::vector< std::string >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_T_resize" "', argument " "2"" of type '" "std::vector< std::string >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::string >::size_type >(val2);
   {
     std::string *ptr = (std::string *)0;
     res3 = SWIG_AsPtr_std_string(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_string_t_resize" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_string_T_resize" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_t_resize" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_T_resize" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -21267,13 +21267,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_resize(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_resize(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_t_resize", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_T_resize", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -21285,7 +21285,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_resize(PyObject *self, PyObject *args
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_string_t_resize__SWIG_0(self, argc, argv);
+        return _wrap_vector_string_T_resize__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -21302,14 +21302,14 @@ SWIGINTERN PyObject *_wrap_vector_string_t_resize(PyObject *self, PyObject *args
         int res = SWIG_AsPtr_std_string(argv[2], (std::string**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vector_string_t_resize__SWIG_1(self, argc, argv);
+          return _wrap_vector_string_T_resize__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_t_resize'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_T_resize'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::string >::resize(std::vector< std::string >::size_type)\n"
     "    std::vector< std::string >::resize(std::vector< std::string >::size_type,std::vector< std::string >::value_type const &)\n");
@@ -21317,7 +21317,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::iterator arg2 ;
@@ -21333,28 +21333,28 @@ SWIGINTERN PyObject *_wrap_vector_string_t_insert__SWIG_0(PyObject *self, Py_ssi
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_insert" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_insert" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t_insert" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T_insert" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::string >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::string >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t_insert" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T_insert" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
     }
   }
   {
     std::string *ptr = (std::string *)0;
     res3 = SWIG_AsPtr_std_string(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_string_t_insert" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_string_T_insert" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_t_insert" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_T_insert" "', argument " "3"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -21369,7 +21369,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_string_T_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::iterator arg2 ;
@@ -21387,33 +21387,33 @@ SWIGINTERN PyObject *_wrap_vector_string_t_insert__SWIG_1(PyObject *self, Py_ssi
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_insert" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_insert" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t_insert" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T_insert" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::string >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::string >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_t_insert" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_string_T_insert" "', argument " "2"" of type '" "std::vector< std::string >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_size_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_string_t_insert" "', argument " "3"" of type '" "std::vector< std::string >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_string_T_insert" "', argument " "3"" of type '" "std::vector< std::string >::size_type""'");
   } 
   arg3 = static_cast< std::vector< std::string >::size_type >(val3);
   {
     std::string *ptr = (std::string *)0;
     res4 = SWIG_AsPtr_std_string(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_string_t_insert" "', argument " "4"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_string_T_insert" "', argument " "4"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_t_insert" "', argument " "4"" of type '" "std::vector< std::string >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_string_T_insert" "', argument " "4"" of type '" "std::vector< std::string >::value_type const &""'"); 
     }
     arg4 = ptr;
   }
@@ -21427,13 +21427,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_insert(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_insert(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_t_insert", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_string_T_insert", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -21447,7 +21447,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_insert(PyObject *self, PyObject *args
         int res = SWIG_AsPtr_std_string(argv[2], (std::string**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vector_string_t_insert__SWIG_0(self, argc, argv);
+          return _wrap_vector_string_T_insert__SWIG_0(self, argc, argv);
         }
       }
     }
@@ -21469,7 +21469,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_insert(PyObject *self, PyObject *args
           int res = SWIG_AsPtr_std_string(argv[3], (std::string**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vector_string_t_insert__SWIG_1(self, argc, argv);
+            return _wrap_vector_string_T_insert__SWIG_1(self, argc, argv);
           }
         }
       }
@@ -21477,7 +21477,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_insert(PyObject *self, PyObject *args
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_t_insert'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_string_T_insert'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::string >::insert(std::vector< std::string >::iterator,std::vector< std::string >::value_type const &)\n"
     "    std::vector< std::string >::insert(std::vector< std::string >::iterator,std::vector< std::string >::size_type,std::vector< std::string >::value_type const &)\n");
@@ -21485,7 +21485,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_reserve(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_reserve(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   std::vector< std::string >::size_type arg2 ;
@@ -21496,15 +21496,15 @@ SWIGINTERN PyObject *_wrap_vector_string_t_reserve(PyObject *self, PyObject *arg
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_string_t_reserve", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_string_T_reserve", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_reserve" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_reserve" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_t_reserve" "', argument " "2"" of type '" "std::vector< std::string >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_string_T_reserve" "', argument " "2"" of type '" "std::vector< std::string >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::string >::size_type >(val2);
   (arg1)->reserve(arg2);
@@ -21515,7 +21515,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_string_t_capacity(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_string_T_capacity(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -21528,7 +21528,7 @@ SWIGINTERN PyObject *_wrap_vector_string_t_capacity(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_t_capacity" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_string_T_capacity" "', argument " "1"" of type '" "std::vector< std::string > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   result = ((std::vector< std::string > const *)arg1)->capacity();
@@ -21539,7 +21539,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_delete_vector_string_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_delete_vector_string_T(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::string > *arg1 = (std::vector< std::string > *) 0 ;
   void *argp1 = 0 ;
@@ -21551,7 +21551,7 @@ SWIGINTERN PyObject *_wrap_delete_vector_string_t(PyObject *self, PyObject *args
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__string_t, SWIG_POINTER_DISOWN |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vector_string_t" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vector_string_T" "', argument " "1"" of type '" "std::vector< std::string > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::string > * >(argp1);
   {
@@ -21572,18 +21572,18 @@ fail:
 }
 
 
-SWIGINTERN PyObject *vector_string_t_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vector_string_T_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   PyObject *obj;
   if (!SWIG_Python_UnpackTuple(args, "swigregister", 1, 1, &obj)) return NULL;
   SWIG_TypeNewClientData(SWIGTYPE_p_std__vectorT_std__string_t, SWIG_NewClientData(obj));
   return SWIG_Py_Void();
 }
 
-SWIGINTERN PyObject *vector_string_t_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vector_string_T_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   return SWIG_Python_InitShadowInstance(args);
 }
 
-SWIGINTERN PyObject *_wrap_new_map_string_double_t__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_map_string_double_T__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::less< std::string > *arg1 = 0 ;
   void *argp1 = 0 ;
@@ -21594,10 +21594,10 @@ SWIGINTERN PyObject *_wrap_new_map_string_double_t__SWIG_0(PyObject *self, Py_ss
   if ((nobjs < 1) || (nobjs > 1)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1, SWIGTYPE_p_std__lessT_std__string_t,  0  | 0);
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_map_string_double_t" "', argument " "1"" of type '" "std::less< std::string > const &""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_map_string_double_T" "', argument " "1"" of type '" "std::less< std::string > const &""'"); 
   }
   if (!argp1) {
-    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_map_string_double_t" "', argument " "1"" of type '" "std::less< std::string > const &""'"); 
+    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_map_string_double_T" "', argument " "1"" of type '" "std::less< std::string > const &""'"); 
   }
   arg1 = reinterpret_cast< std::less< std::string > * >(argp1);
   result = (std::map< std::string,double > *)new std::map< std::string,double >((std::less< std::string > const &)*arg1);
@@ -21608,7 +21608,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_iterator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_iterator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   PyObject **arg2 = (PyObject **) 0 ;
@@ -21623,7 +21623,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_iterator(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_iterator" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_iterator" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (swig::SwigPyIterator *)std_map_Sl_std_string_Sc_double_Sg__iterator(arg1,arg2);
@@ -21634,7 +21634,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t___nonzero__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T___nonzero__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -21647,7 +21647,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t___nonzero__(PyObject *self, PyObj
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t___nonzero__" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T___nonzero__" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (bool)std_map_Sl_std_string_Sc_double_Sg____nonzero__((std::map< std::string,double > const *)arg1);
@@ -21658,7 +21658,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t___bool__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T___bool__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -21671,7 +21671,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t___bool__(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t___bool__" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T___bool__" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (bool)std_map_Sl_std_string_Sc_double_Sg____bool__((std::map< std::string,double > const *)arg1);
@@ -21682,7 +21682,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t___len__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T___len__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -21695,7 +21695,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t___len__(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t___len__" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T___len__" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = std_map_Sl_std_string_Sc_double_Sg____len__((std::map< std::string,double > const *)arg1);
@@ -21706,7 +21706,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t___getitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T___getitem__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::key_type *arg2 = 0 ;
@@ -21717,20 +21717,20 @@ SWIGINTERN PyObject *_wrap_map_string_double_t___getitem__(PyObject *self, PyObj
   std::map< std::string,double >::mapped_type *result = 0 ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "map_string_double_t___getitem__", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "map_string_double_T___getitem__", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t___getitem__" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T___getitem__" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t___getitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T___getitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t___getitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T___getitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -21748,7 +21748,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t___delitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T___delitem__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::key_type *arg2 = 0 ;
@@ -21758,20 +21758,20 @@ SWIGINTERN PyObject *_wrap_map_string_double_t___delitem__(PyObject *self, PyObj
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "map_string_double_t___delitem__", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "map_string_double_T___delitem__", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t___delitem__" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T___delitem__" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t___delitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T___delitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t___delitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T___delitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -21789,7 +21789,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_has_key(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_has_key(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::key_type *arg2 = 0 ;
@@ -21800,20 +21800,20 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_has_key(PyObject *self, PyObject
   bool result;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "map_string_double_t_has_key", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "map_string_double_T_has_key", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_has_key" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_has_key" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t_has_key" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T_has_key" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t_has_key" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T_has_key" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -21827,7 +21827,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_keys(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_keys(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -21840,7 +21840,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_keys(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_keys" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_keys" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (PyObject *)std_map_Sl_std_string_Sc_double_Sg__keys(arg1);
@@ -21851,7 +21851,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_values(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_values(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -21864,7 +21864,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_values(PyObject *self, PyObject *
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_values" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_values" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (PyObject *)std_map_Sl_std_string_Sc_double_Sg__values(arg1);
@@ -21875,7 +21875,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_items(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_items(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -21888,7 +21888,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_items(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_items" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_items" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (PyObject *)std_map_Sl_std_string_Sc_double_Sg__items(arg1);
@@ -21899,7 +21899,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t___contains__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T___contains__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::key_type *arg2 = 0 ;
@@ -21910,20 +21910,20 @@ SWIGINTERN PyObject *_wrap_map_string_double_t___contains__(PyObject *self, PyOb
   bool result;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "map_string_double_t___contains__", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "map_string_double_T___contains__", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t___contains__" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T___contains__" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t___contains__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T___contains__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t___contains__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T___contains__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -21937,7 +21937,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_key_iterator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_key_iterator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   PyObject **arg2 = (PyObject **) 0 ;
@@ -21952,7 +21952,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_key_iterator(PyObject *self, PyOb
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_key_iterator" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_key_iterator" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (swig::SwigPyIterator *)std_map_Sl_std_string_Sc_double_Sg__key_iterator(arg1,arg2);
@@ -21963,7 +21963,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_value_iterator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_value_iterator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   PyObject **arg2 = (PyObject **) 0 ;
@@ -21978,7 +21978,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_value_iterator(PyObject *self, Py
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_value_iterator" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_value_iterator" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (swig::SwigPyIterator *)std_map_Sl_std_string_Sc_double_Sg__value_iterator(arg1,arg2);
@@ -21989,7 +21989,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_map_string_double_T___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::key_type *arg2 = 0 ;
@@ -22001,17 +22001,17 @@ SWIGINTERN PyObject *_wrap_map_string_double_t___setitem____SWIG_0(PyObject *sel
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t___setitem__" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T___setitem__" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t___setitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T___setitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t___setitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T___setitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -22025,7 +22025,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_map_string_double_T___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::key_type *arg2 = 0 ;
@@ -22041,23 +22041,23 @@ SWIGINTERN PyObject *_wrap_map_string_double_t___setitem____SWIG_1(PyObject *sel
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t___setitem__" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T___setitem__" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t___setitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T___setitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t___setitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T___setitem__" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     arg2 = ptr;
   }
   ecode3 = SWIG_AsVal_double(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "map_string_double_t___setitem__" "', argument " "3"" of type '" "std::map< std::string,double >::mapped_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "map_string_double_T___setitem__" "', argument " "3"" of type '" "std::map< std::string,double >::mapped_type""'");
   } 
   temp3 = static_cast< std::map< std::string,double >::mapped_type >(val3);
   arg3 = &temp3;
@@ -22075,13 +22075,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t___setitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T___setitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "map_string_double_t___setitem__", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "map_string_double_T___setitem__", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -22091,7 +22091,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t___setitem__(PyObject *self, PyObj
       int res = SWIG_AsPtr_std_string(argv[1], (std::string**)(0));
       _v = SWIG_CheckState(res);
       if (_v) {
-        return _wrap_map_string_double_t___setitem____SWIG_0(self, argc, argv);
+        return _wrap_map_string_double_T___setitem____SWIG_0(self, argc, argv);
       }
     }
   }
@@ -22108,14 +22108,14 @@ SWIGINTERN PyObject *_wrap_map_string_double_t___setitem__(PyObject *self, PyObj
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_map_string_double_t___setitem____SWIG_1(self, argc, argv);
+          return _wrap_map_string_double_T___setitem____SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'map_string_double_t___setitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'map_string_double_T___setitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::map< std::string,double >::__setitem__(std::map< std::string,double >::key_type const &)\n"
     "    std::map< std::string,double >::__setitem__(std::map< std::string,double >::key_type const &,std::map< std::string,double >::mapped_type const &)\n");
@@ -22123,7 +22123,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_asdict(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_asdict(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -22136,7 +22136,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_asdict(PyObject *self, PyObject *
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_asdict" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_asdict" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (PyObject *)std_map_Sl_std_string_Sc_double_Sg__asdict(arg1);
@@ -22147,7 +22147,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_map_string_double_t__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
+SWIGINTERN PyObject *_wrap_new_map_string_double_T__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *result = 0 ;
   
@@ -22161,7 +22161,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_map_string_double_t__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_map_string_double_T__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = 0 ;
   int res1 = SWIG_OLDOBJ ;
@@ -22173,10 +22173,10 @@ SWIGINTERN PyObject *_wrap_new_map_string_double_t__SWIG_2(PyObject *self, Py_ss
     std::map< std::string,double,std::less< std::string >,std::allocator< std::pair< std::string const,double > > > *ptr = (std::map< std::string,double,std::less< std::string >,std::allocator< std::pair< std::string const,double > > > *)0;
     res1 = swig::asptr(swig_obj[0], &ptr);
     if (!SWIG_IsOK(res1)) {
-      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_map_string_double_t" "', argument " "1"" of type '" "std::map< std::string,double > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_map_string_double_T" "', argument " "1"" of type '" "std::map< std::string,double > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_map_string_double_t" "', argument " "1"" of type '" "std::map< std::string,double > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_map_string_double_T" "', argument " "1"" of type '" "std::map< std::string,double > const &""'"); 
     }
     arg1 = ptr;
   }
@@ -22190,23 +22190,23 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_map_string_double_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_new_map_string_double_T(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[2] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "new_map_string_double_t", 0, 1, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "new_map_string_double_T", 0, 1, argv))) SWIG_fail;
   --argc;
   if (argc == 0) {
-    return _wrap_new_map_string_double_t__SWIG_1(self, argc, argv);
+    return _wrap_new_map_string_double_T__SWIG_1(self, argc, argv);
   }
   if (argc == 1) {
     int _v = 0;
     int res = SWIG_ConvertPtr(argv[0], 0, SWIGTYPE_p_std__lessT_std__string_t, SWIG_POINTER_NO_NULL | 0);
     _v = SWIG_CheckState(res);
     if (_v) {
-      return _wrap_new_map_string_double_t__SWIG_0(self, argc, argv);
+      return _wrap_new_map_string_double_T__SWIG_0(self, argc, argv);
     }
   }
   if (argc == 1) {
@@ -22214,12 +22214,12 @@ SWIGINTERN PyObject *_wrap_new_map_string_double_t(PyObject *self, PyObject *arg
     int res = swig::asptr(argv[0], (std::map< std::string,double,std::less< std::string >,std::allocator< std::pair< std::string const,double > > >**)(0));
     _v = SWIG_CheckState(res);
     if (_v) {
-      return _wrap_new_map_string_double_t__SWIG_2(self, argc, argv);
+      return _wrap_new_map_string_double_T__SWIG_2(self, argc, argv);
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_map_string_double_t'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_map_string_double_T'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::map< std::string,double >::map(std::less< std::string > const &)\n"
     "    std::map< std::string,double >::map()\n"
@@ -22228,7 +22228,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_empty(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_empty(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -22241,7 +22241,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_empty(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_empty" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_empty" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (bool)((std::map< std::string,double > const *)arg1)->empty();
@@ -22252,7 +22252,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_size(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_size(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -22265,7 +22265,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_size(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_size" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_size" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = ((std::map< std::string,double > const *)arg1)->size();
@@ -22276,7 +22276,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_swap(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_swap(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double > *arg2 = 0 ;
@@ -22287,18 +22287,18 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_swap(PyObject *self, PyObject *ar
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "map_string_double_t_swap", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "map_string_double_T_swap", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_swap" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_swap" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], &argp2, SWIGTYPE_p_std__mapT_std__string_double_t,  0 );
   if (!SWIG_IsOK(res2)) {
-    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t_swap" "', argument " "2"" of type '" "std::map< std::string,double > &""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T_swap" "', argument " "2"" of type '" "std::map< std::string,double > &""'"); 
   }
   if (!argp2) {
-    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t_swap" "', argument " "2"" of type '" "std::map< std::string,double > &""'"); 
+    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T_swap" "', argument " "2"" of type '" "std::map< std::string,double > &""'"); 
   }
   arg2 = reinterpret_cast< std::map< std::string,double > * >(argp2);
   (arg1)->swap(*arg2);
@@ -22309,7 +22309,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_begin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_begin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -22322,7 +22322,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_begin(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_begin" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_begin" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (arg1)->begin();
@@ -22334,7 +22334,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_end(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_end(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -22347,7 +22347,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_end(PyObject *self, PyObject *arg
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_end" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_end" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (arg1)->end();
@@ -22359,7 +22359,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_rbegin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_rbegin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -22372,7 +22372,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_rbegin(PyObject *self, PyObject *
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_rbegin" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_rbegin" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (arg1)->rbegin();
@@ -22384,7 +22384,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_rend(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_rend(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -22397,7 +22397,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_rend(PyObject *self, PyObject *ar
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_rend" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_rend" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = (arg1)->rend();
@@ -22409,7 +22409,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_clear(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_clear(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -22421,7 +22421,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_clear(PyObject *self, PyObject *a
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_clear" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_clear" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   (arg1)->clear();
@@ -22432,7 +22432,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_get_allocator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_get_allocator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -22445,7 +22445,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_get_allocator(PyObject *self, PyO
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_get_allocator" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_get_allocator" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   result = ((std::map< std::string,double > const *)arg1)->get_allocator();
@@ -22456,7 +22456,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::key_type *arg2 = 0 ;
@@ -22469,17 +22469,17 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_erase__SWIG_0(PyObject *self, Py_
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_erase" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_erase" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t_erase" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T_erase" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t_erase" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T_erase" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -22493,7 +22493,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_count(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_count(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::key_type *arg2 = 0 ;
@@ -22504,20 +22504,20 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_count(PyObject *self, PyObject *a
   std::map< std::string,double >::size_type result;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "map_string_double_t_count", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "map_string_double_T_count", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_count" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_count" "', argument " "1"" of type '" "std::map< std::string,double > const *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t_count" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T_count" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t_count" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T_count" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -22531,7 +22531,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::iterator arg2 ;
@@ -22544,18 +22544,18 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_erase__SWIG_1(PyObject *self, Py_
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_erase" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_erase" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_t_erase" "', argument " "2"" of type '" "std::map< std::string,double >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_T_erase" "', argument " "2"" of type '" "std::map< std::string,double >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::map< std::string,double >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::map< std::string,double >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_t_erase" "', argument " "2"" of type '" "std::map< std::string,double >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_T_erase" "', argument " "2"" of type '" "std::map< std::string,double >::iterator""'");
     }
   }
   std_map_Sl_std_string_Sc_double_Sg__erase__SWIG_1(arg1,SWIG_STD_MOVE(arg2));
@@ -22566,7 +22566,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_erase__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_erase__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::iterator arg2 ;
@@ -22582,29 +22582,29 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_erase__SWIG_2(PyObject *self, Py_
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_erase" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_erase" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_t_erase" "', argument " "2"" of type '" "std::map< std::string,double >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_T_erase" "', argument " "2"" of type '" "std::map< std::string,double >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::map< std::string,double >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::map< std::string,double >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_t_erase" "', argument " "2"" of type '" "std::map< std::string,double >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_T_erase" "', argument " "2"" of type '" "std::map< std::string,double >::iterator""'");
     }
   }
   res3 = SWIG_ConvertPtr(swig_obj[2], SWIG_as_voidptrptr(&iter3), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res3) || !iter3) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_t_erase" "', argument " "3"" of type '" "std::map< std::string,double >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_T_erase" "', argument " "3"" of type '" "std::map< std::string,double >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::map< std::string,double >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::map< std::string,double >::iterator > *>(iter3);
     if (iter_t) {
       arg3 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_t_erase" "', argument " "3"" of type '" "std::map< std::string,double >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "map_string_double_T_erase" "', argument " "3"" of type '" "std::map< std::string,double >::iterator""'");
     }
   }
   std_map_Sl_std_string_Sc_double_Sg__erase__SWIG_2(arg1,SWIG_STD_MOVE(arg2),SWIG_STD_MOVE(arg3));
@@ -22615,13 +22615,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_erase(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_erase(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "map_string_double_t_erase", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "map_string_double_T_erase", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -22632,7 +22632,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_erase(PyObject *self, PyObject *a
       int res = SWIG_ConvertPtr(argv[1], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
       _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::map< std::string,double >::iterator > *>(iter) != 0));
       if (_v) {
-        return _wrap_map_string_double_t_erase__SWIG_1(self, argc, argv);
+        return _wrap_map_string_double_T_erase__SWIG_1(self, argc, argv);
       }
     }
   }
@@ -22644,7 +22644,7 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_erase(PyObject *self, PyObject *a
       int res = SWIG_AsPtr_std_string(argv[1], (std::string**)(0));
       _v = SWIG_CheckState(res);
       if (_v) {
-        return _wrap_map_string_double_t_erase__SWIG_0(self, argc, argv);
+        return _wrap_map_string_double_T_erase__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -22661,14 +22661,14 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_erase(PyObject *self, PyObject *a
         int res = SWIG_ConvertPtr(argv[2], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
         _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::map< std::string,double >::iterator > *>(iter) != 0));
         if (_v) {
-          return _wrap_map_string_double_t_erase__SWIG_2(self, argc, argv);
+          return _wrap_map_string_double_T_erase__SWIG_2(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'map_string_double_t_erase'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'map_string_double_T_erase'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::map< std::string,double >::erase(std::map< std::string,double >::key_type const &)\n"
     "    std::map< std::string,double >::erase(std::map< std::string,double >::iterator)\n"
@@ -22677,7 +22677,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_find(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_find(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::key_type *arg2 = 0 ;
@@ -22688,20 +22688,20 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_find(PyObject *self, PyObject *ar
   std::map< std::string,double >::iterator result;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "map_string_double_t_find", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "map_string_double_T_find", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_find" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_find" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t_find" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T_find" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t_find" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T_find" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -22716,7 +22716,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_lower_bound(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_lower_bound(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::key_type *arg2 = 0 ;
@@ -22727,20 +22727,20 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_lower_bound(PyObject *self, PyObj
   std::map< std::string,double >::iterator result;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "map_string_double_t_lower_bound", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "map_string_double_T_lower_bound", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_lower_bound" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_lower_bound" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t_lower_bound" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T_lower_bound" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t_lower_bound" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T_lower_bound" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -22755,7 +22755,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_map_string_double_t_upper_bound(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_map_string_double_T_upper_bound(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   std::map< std::string,double >::key_type *arg2 = 0 ;
@@ -22766,20 +22766,20 @@ SWIGINTERN PyObject *_wrap_map_string_double_t_upper_bound(PyObject *self, PyObj
   std::map< std::string,double >::iterator result;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "map_string_double_t_upper_bound", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "map_string_double_T_upper_bound", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_t_upper_bound" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "map_string_double_T_upper_bound" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
     std::string *ptr = (std::string *)0;
     res2 = SWIG_AsPtr_std_string(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_t_upper_bound" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "map_string_double_T_upper_bound" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_t_upper_bound" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "map_string_double_T_upper_bound" "', argument " "2"" of type '" "std::map< std::string,double >::key_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -22794,7 +22794,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_delete_map_string_double_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_delete_map_string_double_T(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::map< std::string,double > *arg1 = (std::map< std::string,double > *) 0 ;
   void *argp1 = 0 ;
@@ -22806,7 +22806,7 @@ SWIGINTERN PyObject *_wrap_delete_map_string_double_t(PyObject *self, PyObject *
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__mapT_std__string_double_t, SWIG_POINTER_DISOWN |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_map_string_double_t" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_map_string_double_T" "', argument " "1"" of type '" "std::map< std::string,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::map< std::string,double > * >(argp1);
   {
@@ -22827,18 +22827,18 @@ fail:
 }
 
 
-SWIGINTERN PyObject *map_string_double_t_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *map_string_double_T_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   PyObject *obj;
   if (!SWIG_Python_UnpackTuple(args, "swigregister", 1, 1, &obj)) return NULL;
   SWIG_TypeNewClientData(SWIGTYPE_p_std__mapT_std__string_double_t, SWIG_NewClientData(obj));
   return SWIG_Py_Void();
 }
 
-SWIGINTERN PyObject *map_string_double_t_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *map_string_double_T_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   return SWIG_Python_InitShadowInstance(args);
 }
 
-SWIGINTERN PyObject *_wrap_new_pvacuum_double_t__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
+SWIGINTERN PyObject *_wrap_new_pvacuum_double_T__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
   PyObject *resultobj = 0;
   std::pair< double,double > *result = 0 ;
   
@@ -22852,7 +22852,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_pvacuum_double_t__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_pvacuum_double_T__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   double arg1 ;
   double arg2 ;
@@ -22866,12 +22866,12 @@ SWIGINTERN PyObject *_wrap_new_pvacuum_double_t__SWIG_1(PyObject *self, Py_ssize
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   ecode1 = SWIG_AsVal_double(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_pvacuum_double_t" "', argument " "1"" of type '" "double""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_pvacuum_double_T" "', argument " "1"" of type '" "double""'");
   } 
   arg1 = static_cast< double >(val1);
   ecode2 = SWIG_AsVal_double(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "new_pvacuum_double_t" "', argument " "2"" of type '" "double""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "new_pvacuum_double_T" "', argument " "2"" of type '" "double""'");
   } 
   arg2 = static_cast< double >(val2);
   result = (std::pair< double,double > *)new std::pair< double,double >(arg1,arg2);
@@ -22882,7 +22882,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_pvacuum_double_t__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_pvacuum_double_T__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::pair< double,double > *arg1 = 0 ;
   int res1 = SWIG_OLDOBJ ;
@@ -22894,10 +22894,10 @@ SWIGINTERN PyObject *_wrap_new_pvacuum_double_t__SWIG_2(PyObject *self, Py_ssize
     std::pair< double,double > *ptr = (std::pair< double,double > *)0;
     res1 = swig::asptr(swig_obj[0], &ptr);
     if (!SWIG_IsOK(res1)) {
-      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_pvacuum_double_t" "', argument " "1"" of type '" "std::pair< double,double > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_pvacuum_double_T" "', argument " "1"" of type '" "std::pair< double,double > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_pvacuum_double_t" "', argument " "1"" of type '" "std::pair< double,double > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_pvacuum_double_T" "', argument " "1"" of type '" "std::pair< double,double > const &""'"); 
     }
     arg1 = ptr;
   }
@@ -22911,23 +22911,23 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_pvacuum_double_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_new_pvacuum_double_T(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "new_pvacuum_double_t", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "new_pvacuum_double_T", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 0) {
-    return _wrap_new_pvacuum_double_t__SWIG_0(self, argc, argv);
+    return _wrap_new_pvacuum_double_T__SWIG_0(self, argc, argv);
   }
   if (argc == 1) {
     int _v = 0;
     int res = swig::asptr(argv[0], (std::pair< double,double >**)(0));
     _v = SWIG_CheckState(res);
     if (_v) {
-      return _wrap_new_pvacuum_double_t__SWIG_2(self, argc, argv);
+      return _wrap_new_pvacuum_double_T__SWIG_2(self, argc, argv);
     }
   }
   if (argc == 2) {
@@ -22942,13 +22942,13 @@ SWIGINTERN PyObject *_wrap_new_pvacuum_double_t(PyObject *self, PyObject *args)
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_new_pvacuum_double_t__SWIG_1(self, argc, argv);
+        return _wrap_new_pvacuum_double_T__SWIG_1(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_pvacuum_double_t'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_pvacuum_double_T'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::pair< double,double >::pair()\n"
     "    std::pair< double,double >::pair(double,double)\n"
@@ -22957,7 +22957,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_pvacuum_double_t_first_set(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_pvacuum_double_T_first_set(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::pair< double,double > *arg1 = (std::pair< double,double > *) 0 ;
   double arg2 ;
@@ -22968,15 +22968,15 @@ SWIGINTERN PyObject *_wrap_pvacuum_double_t_first_set(PyObject *self, PyObject *
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "pvacuum_double_t_first_set", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "pvacuum_double_T_first_set", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__pairT_double_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "pvacuum_double_t_first_set" "', argument " "1"" of type '" "std::pair< double,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "pvacuum_double_T_first_set" "', argument " "1"" of type '" "std::pair< double,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::pair< double,double > * >(argp1);
   ecode2 = SWIG_AsVal_double(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "pvacuum_double_t_first_set" "', argument " "2"" of type '" "double""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "pvacuum_double_T_first_set" "', argument " "2"" of type '" "double""'");
   } 
   arg2 = static_cast< double >(val2);
   if (arg1) (arg1)->first = arg2;
@@ -22987,7 +22987,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_pvacuum_double_t_first_get(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_pvacuum_double_T_first_get(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::pair< double,double > *arg1 = (std::pair< double,double > *) 0 ;
   void *argp1 = 0 ;
@@ -23000,7 +23000,7 @@ SWIGINTERN PyObject *_wrap_pvacuum_double_t_first_get(PyObject *self, PyObject *
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__pairT_double_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "pvacuum_double_t_first_get" "', argument " "1"" of type '" "std::pair< double,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "pvacuum_double_T_first_get" "', argument " "1"" of type '" "std::pair< double,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::pair< double,double > * >(argp1);
   result = (double) ((arg1)->first);
@@ -23011,7 +23011,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_pvacuum_double_t_second_set(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_pvacuum_double_T_second_set(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::pair< double,double > *arg1 = (std::pair< double,double > *) 0 ;
   double arg2 ;
@@ -23022,15 +23022,15 @@ SWIGINTERN PyObject *_wrap_pvacuum_double_t_second_set(PyObject *self, PyObject
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "pvacuum_double_t_second_set", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "pvacuum_double_T_second_set", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__pairT_double_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "pvacuum_double_t_second_set" "', argument " "1"" of type '" "std::pair< double,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "pvacuum_double_T_second_set" "', argument " "1"" of type '" "std::pair< double,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::pair< double,double > * >(argp1);
   ecode2 = SWIG_AsVal_double(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "pvacuum_double_t_second_set" "', argument " "2"" of type '" "double""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "pvacuum_double_T_second_set" "', argument " "2"" of type '" "double""'");
   } 
   arg2 = static_cast< double >(val2);
   if (arg1) (arg1)->second = arg2;
@@ -23041,7 +23041,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_pvacuum_double_t_second_get(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_pvacuum_double_T_second_get(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::pair< double,double > *arg1 = (std::pair< double,double > *) 0 ;
   void *argp1 = 0 ;
@@ -23054,7 +23054,7 @@ SWIGINTERN PyObject *_wrap_pvacuum_double_t_second_get(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__pairT_double_double_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "pvacuum_double_t_second_get" "', argument " "1"" of type '" "std::pair< double,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "pvacuum_double_T_second_get" "', argument " "1"" of type '" "std::pair< double,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::pair< double,double > * >(argp1);
   result = (double) ((arg1)->second);
@@ -23065,7 +23065,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_delete_pvacuum_double_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_delete_pvacuum_double_T(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::pair< double,double > *arg1 = (std::pair< double,double > *) 0 ;
   void *argp1 = 0 ;
@@ -23077,7 +23077,7 @@ SWIGINTERN PyObject *_wrap_delete_pvacuum_double_t(PyObject *self, PyObject *arg
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__pairT_double_double_t, SWIG_POINTER_DISOWN |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_pvacuum_double_t" "', argument " "1"" of type '" "std::pair< double,double > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_pvacuum_double_T" "', argument " "1"" of type '" "std::pair< double,double > *""'"); 
   }
   arg1 = reinterpret_cast< std::pair< double,double > * >(argp1);
   {
@@ -23098,18 +23098,18 @@ fail:
 }
 
 
-SWIGINTERN PyObject *pvacuum_double_t_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *pvacuum_double_T_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   PyObject *obj;
   if (!SWIG_Python_UnpackTuple(args, "swigregister", 1, 1, &obj)) return NULL;
   SWIG_TypeNewClientData(SWIGTYPE_p_std__pairT_double_double_t, SWIG_NewClientData(obj));
   return SWIG_Py_Void();
 }
 
-SWIGINTERN PyObject *pvacuum_double_t_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *pvacuum_double_T_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   return SWIG_Python_InitShadowInstance(args);
 }
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_iterator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_iterator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   PyObject **arg2 = (PyObject **) 0 ;
@@ -23124,7 +23124,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_iterator(PyObject *self, PyOb
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_iterator" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_iterator" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = (swig::SwigPyIterator *)std_vector_Sl_std_pair_Sl_double_Sc_double_Sg__Sg__iterator(arg1,arg2);
@@ -23135,7 +23135,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___nonzero__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___nonzero__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -23148,7 +23148,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___nonzero__(PyObject *self, P
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___nonzero__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___nonzero__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = (bool)std_vector_Sl_std_pair_Sl_double_Sc_double_Sg__Sg____nonzero__((std::vector< std::pair< double,double > > const *)arg1);
@@ -23159,7 +23159,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___bool__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___bool__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -23172,7 +23172,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___bool__(PyObject *self, PyOb
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___bool__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___bool__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = (bool)std_vector_Sl_std_pair_Sl_double_Sc_double_Sg__Sg____bool__((std::vector< std::pair< double,double > > const *)arg1);
@@ -23183,7 +23183,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___len__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___len__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -23196,7 +23196,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___len__(PyObject *self, PyObj
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___len__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___len__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = std_vector_Sl_std_pair_Sl_double_Sc_double_Sg__Sg____len__((std::vector< std::pair< double,double > > const *)arg1);
@@ -23207,7 +23207,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___getslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___getslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::difference_type arg2 ;
@@ -23222,20 +23222,20 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___getslice__(PyObject *self,
   std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > *result = 0 ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t___getslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T___getslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___getslice__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___getslice__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_t___getslice__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_T___getslice__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::pair< double,double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_pvacuum_double_t___getslice__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_pvacuum_double_T___getslice__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::pair< double,double > >::difference_type >(val3);
   try {
@@ -23252,7 +23252,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___setslice____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::difference_type arg2 ;
@@ -23268,17 +23268,17 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setslice____SWIG_0(PyObject
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___setslice__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___setslice__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_t___setslice__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_T___setslice__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::pair< double,double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_pvacuum_double_t___setslice__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_pvacuum_double_T___setslice__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::pair< double,double > >::difference_type >(val3);
   try {
@@ -23295,7 +23295,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___setslice____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::difference_type arg2 ;
@@ -23313,27 +23313,27 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setslice____SWIG_1(PyObject
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___setslice__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___setslice__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_t___setslice__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_T___setslice__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::pair< double,double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_pvacuum_double_t___setslice__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_pvacuum_double_T___setslice__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::pair< double,double > >::difference_type >(val3);
   {
     std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > *ptr = (std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > *)0;
     res4 = swig::asptr(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_pvacuum_double_t___setslice__" "', argument " "4"" of type '" "std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_pvacuum_double_T___setslice__" "', argument " "4"" of type '" "std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_t___setslice__" "', argument " "4"" of type '" "std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_T___setslice__" "', argument " "4"" of type '" "std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > const &""'"); 
     }
     arg4 = ptr;
   }
@@ -23353,13 +23353,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___setslice__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t___setslice__", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T___setslice__", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -23376,7 +23376,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setslice__(PyObject *self,
           _v = SWIG_CheckState(res);
         }
         if (_v) {
-          return _wrap_vector_pvacuum_double_t___setslice____SWIG_0(self, argc, argv);
+          return _wrap_vector_pvacuum_double_T___setslice____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -23399,7 +23399,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setslice__(PyObject *self,
           int res = swig::asptr(argv[3], (std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > >**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vector_pvacuum_double_t___setslice____SWIG_1(self, argc, argv);
+            return _wrap_vector_pvacuum_double_T___setslice____SWIG_1(self, argc, argv);
           }
         }
       }
@@ -23407,7 +23407,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setslice__(PyObject *self,
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_t___setslice__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_T___setslice__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::pair< double,double > >::__setslice__(std::vector< std::pair< double,double > >::difference_type,std::vector< std::pair< double,double > >::difference_type)\n"
     "    std::vector< std::pair< double,double > >::__setslice__(std::vector< std::pair< double,double > >::difference_type,std::vector< std::pair< double,double > >::difference_type,std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > const &)\n");
@@ -23415,7 +23415,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___delslice__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___delslice__(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::difference_type arg2 ;
@@ -23429,20 +23429,20 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___delslice__(PyObject *self,
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t___delslice__", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T___delslice__", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___delslice__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___delslice__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_t___delslice__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_T___delslice__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::pair< double,double > >::difference_type >(val2);
   ecode3 = SWIG_AsVal_ptrdiff_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_pvacuum_double_t___delslice__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_pvacuum_double_T___delslice__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
   } 
   arg3 = static_cast< std::vector< std::pair< double,double > >::difference_type >(val3);
   try {
@@ -23459,7 +23459,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___delitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::difference_type arg2 ;
@@ -23472,12 +23472,12 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___delitem____SWIG_0(PyObject
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___delitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___delitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_t___delitem__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_T___delitem__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::pair< double,double > >::difference_type >(val2);
   try {
@@ -23494,7 +23494,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___getitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -23506,12 +23506,12 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___getitem____SWIG_0(PyObject
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___getitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___getitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T___getitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -23529,7 +23529,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___setitem____SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -23542,12 +23542,12 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setitem____SWIG_0(PyObject
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___setitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___setitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -23555,10 +23555,10 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setitem____SWIG_0(PyObject
     std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > *ptr = (std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_pvacuum_double_t___setitem__" "', argument " "3"" of type '" "std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_pvacuum_double_T___setitem__" "', argument " "3"" of type '" "std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_t___setitem__" "', argument " "3"" of type '" "std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_T___setitem__" "', argument " "3"" of type '" "std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > const &""'"); 
     }
     arg3 = ptr;
   }
@@ -23578,7 +23578,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___setitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -23589,12 +23589,12 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setitem____SWIG_1(PyObject
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___setitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___setitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T___setitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -23612,7 +23612,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___delitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   SWIGPY_SLICEOBJECT *arg2 = (SWIGPY_SLICEOBJECT *) 0 ;
@@ -23623,12 +23623,12 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___delitem____SWIG_1(PyObject
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___delitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___delitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   {
     if (!PySlice_Check(swig_obj[1])) {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T___delitem__" "', argument " "2"" of type '" "SWIGPY_SLICEOBJECT *""'");
     }
     arg2 = (SWIGPY_SLICEOBJECT *) swig_obj[1];
   }
@@ -23646,13 +23646,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___delitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___delitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t___delitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T___delitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -23663,7 +23663,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___delitem__(PyObject *self, P
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_pvacuum_double_t___delitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_pvacuum_double_T___delitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -23677,13 +23677,13 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___delitem__(PyObject *self, P
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_pvacuum_double_t___delitem____SWIG_0(self, argc, argv);
+        return _wrap_vector_pvacuum_double_T___delitem____SWIG_0(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_t___delitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_T___delitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::pair< double,double > >::__delitem__(std::vector< std::pair< double,double > >::difference_type)\n"
     "    std::vector< std::pair< double,double > >::__delitem__(SWIGPY_SLICEOBJECT *)\n");
@@ -23691,7 +23691,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___getitem____SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::difference_type arg2 ;
@@ -23705,12 +23705,12 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___getitem____SWIG_1(PyObject
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___getitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___getitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_t___getitem__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_T___getitem__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::pair< double,double > >::difference_type >(val2);
   try {
@@ -23726,13 +23726,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___getitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___getitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t___getitem__", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T___getitem__", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -23743,7 +23743,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___getitem__(PyObject *self, P
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_pvacuum_double_t___getitem____SWIG_0(self, argc, argv);
+        return _wrap_vector_pvacuum_double_T___getitem____SWIG_0(self, argc, argv);
       }
     }
   }
@@ -23757,13 +23757,13 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___getitem__(PyObject *self, P
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_pvacuum_double_t___getitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_pvacuum_double_T___getitem____SWIG_1(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_t___getitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_T___getitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::pair< double,double > >::__getitem__(SWIGPY_SLICEOBJECT *)\n"
     "    std::vector< std::pair< double,double > >::__getitem__(std::vector< std::pair< double,double > >::difference_type) const\n");
@@ -23771,7 +23771,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___setitem____SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::difference_type arg2 ;
@@ -23786,22 +23786,22 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setitem____SWIG_2(PyObject
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t___setitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T___setitem__" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   ecode2 = SWIG_AsVal_ptrdiff_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_t___setitem__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_T___setitem__" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::difference_type""'");
   } 
   arg2 = static_cast< std::vector< std::pair< double,double > >::difference_type >(val2);
   {
     std::pair< double,double > *ptr = (std::pair< double,double > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_pvacuum_double_t___setitem__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_pvacuum_double_T___setitem__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_t___setitem__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_T___setitem__" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -23819,13 +23819,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setitem__(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T___setitem__(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t___setitem__", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T___setitem__", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -23836,7 +23836,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setitem__(PyObject *self, P
         _v = PySlice_Check(argv[1]);
       }
       if (_v) {
-        return _wrap_vector_pvacuum_double_t___setitem____SWIG_1(self, argc, argv);
+        return _wrap_vector_pvacuum_double_T___setitem____SWIG_1(self, argc, argv);
       }
     }
   }
@@ -23852,7 +23852,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setitem__(PyObject *self, P
         int res = swig::asptr(argv[2], (std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vector_pvacuum_double_t___setitem____SWIG_0(self, argc, argv);
+          return _wrap_vector_pvacuum_double_T___setitem____SWIG_0(self, argc, argv);
         }
       }
     }
@@ -23870,14 +23870,14 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t___setitem__(PyObject *self, P
         int res = swig::asptr(argv[2], (std::pair< double,double >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vector_pvacuum_double_t___setitem____SWIG_2(self, argc, argv);
+          return _wrap_vector_pvacuum_double_T___setitem____SWIG_2(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_t___setitem__'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_T___setitem__'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::pair< double,double > >::__setitem__(SWIGPY_SLICEOBJECT *,std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > const &)\n"
     "    std::vector< std::pair< double,double > >::__setitem__(SWIGPY_SLICEOBJECT *)\n"
@@ -23886,7 +23886,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_pop(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_pop(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -23899,7 +23899,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_pop(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_pop" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_pop" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   try {
@@ -23914,7 +23914,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_append(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_append(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::value_type *arg2 = 0 ;
@@ -23924,20 +23924,20 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_append(PyObject *self, PyObje
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t_append", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T_append", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_append" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_append" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   {
     std::pair< double,double > *ptr = (std::pair< double,double > *)0;
     res2 = swig::asptr(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_pvacuum_double_t_append" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_pvacuum_double_T_append" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_t_append" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_T_append" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -23951,7 +23951,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_t__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
+SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_T__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **SWIGUNUSEDPARM(swig_obj)) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *result = 0 ;
   
@@ -23965,7 +23965,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_t__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_T__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = 0 ;
   int res1 = SWIG_OLDOBJ ;
@@ -23977,10 +23977,10 @@ SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_t__SWIG_1(PyObject *self, P
     std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > *ptr = (std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > > *)0;
     res1 = swig::asptr(swig_obj[0], &ptr);
     if (!SWIG_IsOK(res1)) {
-      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vector_pvacuum_double_t" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "new_vector_pvacuum_double_T" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_pvacuum_double_t" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_pvacuum_double_T" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const &""'"); 
     }
     arg1 = ptr;
   }
@@ -23994,7 +23994,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_empty(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_empty(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -24007,7 +24007,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_empty(PyObject *self, PyObjec
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_empty" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_empty" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = (bool)((std::vector< std::pair< double,double > > const *)arg1)->empty();
@@ -24018,7 +24018,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_size(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_size(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -24031,7 +24031,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_size(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_size" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_size" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = ((std::vector< std::pair< double,double > > const *)arg1)->size();
@@ -24042,7 +24042,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_swap(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_swap(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > > *arg2 = 0 ;
@@ -24053,18 +24053,18 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_swap(PyObject *self, PyObject
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t_swap", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T_swap", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_swap" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_swap" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], &argp2, SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t,  0 );
   if (!SWIG_IsOK(res2)) {
-    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_pvacuum_double_t_swap" "', argument " "2"" of type '" "std::vector< std::pair< double,double > > &""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_pvacuum_double_T_swap" "', argument " "2"" of type '" "std::vector< std::pair< double,double > > &""'"); 
   }
   if (!argp2) {
-    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_t_swap" "', argument " "2"" of type '" "std::vector< std::pair< double,double > > &""'"); 
+    SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_T_swap" "', argument " "2"" of type '" "std::vector< std::pair< double,double > > &""'"); 
   }
   arg2 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp2);
   (arg1)->swap(*arg2);
@@ -24075,7 +24075,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_begin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_begin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -24088,7 +24088,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_begin(PyObject *self, PyObjec
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_begin" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_begin" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = (arg1)->begin();
@@ -24100,7 +24100,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_end(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_end(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -24113,7 +24113,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_end(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_end" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_end" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = (arg1)->end();
@@ -24125,7 +24125,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_rbegin(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_rbegin(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -24138,7 +24138,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_rbegin(PyObject *self, PyObje
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_rbegin" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_rbegin" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = (arg1)->rbegin();
@@ -24150,7 +24150,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_rend(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_rend(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -24163,7 +24163,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_rend(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_rend" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_rend" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = (arg1)->rend();
@@ -24175,7 +24175,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_clear(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_clear(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -24187,7 +24187,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_clear(PyObject *self, PyObjec
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_clear" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_clear" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   (arg1)->clear();
@@ -24198,7 +24198,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_get_allocator(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_get_allocator(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -24211,7 +24211,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_get_allocator(PyObject *self,
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_get_allocator" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_get_allocator" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = ((std::vector< std::pair< double,double > > const *)arg1)->get_allocator();
@@ -24222,7 +24222,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_t__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_T__SWIG_2(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > >::size_type arg1 ;
   size_t val1 ;
@@ -24233,7 +24233,7 @@ SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_t__SWIG_2(PyObject *self, P
   if ((nobjs < 1) || (nobjs > 1)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_pvacuum_double_t" "', argument " "1"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_pvacuum_double_T" "', argument " "1"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
   } 
   arg1 = static_cast< std::vector< std::pair< double,double > >::size_type >(val1);
   result = (std::vector< std::pair< double,double > > *)new std::vector< std::pair< double,double > >(arg1);
@@ -24244,7 +24244,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_pop_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_pop_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -24256,7 +24256,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_pop_back(PyObject *self, PyOb
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_pop_back" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_pop_back" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   (arg1)->pop_back();
@@ -24267,7 +24267,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_resize__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::size_type arg2 ;
@@ -24280,12 +24280,12 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_resize__SWIG_0(PyObject *self
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_resize" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_resize" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_t_resize" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_T_resize" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::pair< double,double > >::size_type >(val2);
   (arg1)->resize(arg2);
@@ -24296,7 +24296,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_erase__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::iterator arg2 ;
@@ -24310,18 +24310,18 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_erase__SWIG_0(PyObject *self,
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_erase" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_erase" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t_erase" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T_erase" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t_erase" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T_erase" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
     }
   }
   result = std_vector_Sl_std_pair_Sl_double_Sc_double_Sg__Sg__erase__SWIG_0(arg1,SWIG_STD_MOVE(arg2));
@@ -24333,7 +24333,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_erase__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::iterator arg2 ;
@@ -24350,29 +24350,29 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_erase__SWIG_1(PyObject *self,
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_erase" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_erase" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t_erase" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T_erase" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t_erase" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T_erase" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
     }
   }
   res3 = SWIG_ConvertPtr(swig_obj[2], SWIG_as_voidptrptr(&iter3), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res3) || !iter3) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t_erase" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T_erase" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *>(iter3);
     if (iter_t) {
       arg3 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t_erase" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T_erase" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
     }
   }
   result = std_vector_Sl_std_pair_Sl_double_Sc_double_Sg__Sg__erase__SWIG_1(arg1,SWIG_STD_MOVE(arg2),SWIG_STD_MOVE(arg3));
@@ -24384,13 +24384,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_erase(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_erase(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t_erase", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T_erase", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -24401,7 +24401,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_erase(PyObject *self, PyObjec
       int res = SWIG_ConvertPtr(argv[1], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
       _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *>(iter) != 0));
       if (_v) {
-        return _wrap_vector_pvacuum_double_t_erase__SWIG_0(self, argc, argv);
+        return _wrap_vector_pvacuum_double_T_erase__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -24418,14 +24418,14 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_erase(PyObject *self, PyObjec
         int res = SWIG_ConvertPtr(argv[2], SWIG_as_voidptrptr(&iter), swig::SwigPyIterator::descriptor(), 0);
         _v = (SWIG_IsOK(res) && iter && (dynamic_cast<swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *>(iter) != 0));
         if (_v) {
-          return _wrap_vector_pvacuum_double_t_erase__SWIG_1(self, argc, argv);
+          return _wrap_vector_pvacuum_double_T_erase__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_t_erase'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_T_erase'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::pair< double,double > >::erase(std::vector< std::pair< double,double > >::iterator)\n"
     "    std::vector< std::pair< double,double > >::erase(std::vector< std::pair< double,double > >::iterator,std::vector< std::pair< double,double > >::iterator)\n");
@@ -24433,7 +24433,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_t__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_T__SWIG_3(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > >::size_type arg1 ;
   std::vector< std::pair< double,double > >::value_type *arg2 = 0 ;
@@ -24446,17 +24446,17 @@ SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_t__SWIG_3(PyObject *self, P
   if ((nobjs < 2) || (nobjs > 2)) SWIG_fail;
   ecode1 = SWIG_AsVal_size_t(swig_obj[0], &val1);
   if (!SWIG_IsOK(ecode1)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_pvacuum_double_t" "', argument " "1"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode1), "in method '" "new_vector_pvacuum_double_T" "', argument " "1"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
   } 
   arg1 = static_cast< std::vector< std::pair< double,double > >::size_type >(val1);
   {
     std::pair< double,double > *ptr = (std::pair< double,double > *)0;
     res2 = swig::asptr(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "new_vector_pvacuum_double_t" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "new_vector_pvacuum_double_T" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_pvacuum_double_t" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "new_vector_pvacuum_double_T" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -24470,16 +24470,16 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_T(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[3] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vector_pvacuum_double_t", 0, 2, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "new_vector_pvacuum_double_T", 0, 2, argv))) SWIG_fail;
   --argc;
   if (argc == 0) {
-    return _wrap_new_vector_pvacuum_double_t__SWIG_0(self, argc, argv);
+    return _wrap_new_vector_pvacuum_double_T__SWIG_0(self, argc, argv);
   }
   if (argc == 1) {
     int _v = 0;
@@ -24488,7 +24488,7 @@ SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_t(PyObject *self, PyObject
       _v = SWIG_CheckState(res);
     }
     if (_v) {
-      return _wrap_new_vector_pvacuum_double_t__SWIG_2(self, argc, argv);
+      return _wrap_new_vector_pvacuum_double_T__SWIG_2(self, argc, argv);
     }
   }
   if (argc == 1) {
@@ -24496,7 +24496,7 @@ SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_t(PyObject *self, PyObject
     int res = swig::asptr(argv[0], (std::vector< std::pair< double,double >,std::allocator< std::pair< double,double > > >**)(0));
     _v = SWIG_CheckState(res);
     if (_v) {
-      return _wrap_new_vector_pvacuum_double_t__SWIG_1(self, argc, argv);
+      return _wrap_new_vector_pvacuum_double_T__SWIG_1(self, argc, argv);
     }
   }
   if (argc == 2) {
@@ -24509,13 +24509,13 @@ SWIGINTERN PyObject *_wrap_new_vector_pvacuum_double_t(PyObject *self, PyObject
       int res = swig::asptr(argv[1], (std::pair< double,double >**)(0));
       _v = SWIG_CheckState(res);
       if (_v) {
-        return _wrap_new_vector_pvacuum_double_t__SWIG_3(self, argc, argv);
+        return _wrap_new_vector_pvacuum_double_T__SWIG_3(self, argc, argv);
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vector_pvacuum_double_t'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'new_vector_pvacuum_double_T'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::pair< double,double > >::vector()\n"
     "    std::vector< std::pair< double,double > >::vector(std::vector< std::pair< double,double > > const &)\n"
@@ -24525,7 +24525,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_push_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_push_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::value_type *arg2 = 0 ;
@@ -24535,20 +24535,20 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_push_back(PyObject *self, PyO
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t_push_back", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T_push_back", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_push_back" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_push_back" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   {
     std::pair< double,double > *ptr = (std::pair< double,double > *)0;
     res2 = swig::asptr(swig_obj[1], &ptr);
     if (!SWIG_IsOK(res2)) {
-      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_pvacuum_double_t_push_back" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res2), "in method '" "vector_pvacuum_double_T_push_back" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_t_push_back" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_T_push_back" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     arg2 = ptr;
   }
@@ -24562,7 +24562,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_front(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_front(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -24575,7 +24575,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_front(PyObject *self, PyObjec
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_front" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_front" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = (std::vector< std::pair< double,double > >::value_type *) &((std::vector< std::pair< double,double > > const *)arg1)->front();
@@ -24587,7 +24587,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_back(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_back(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -24600,7 +24600,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_back(PyObject *self, PyObject
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_back" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_back" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = (std::vector< std::pair< double,double > >::value_type *) &((std::vector< std::pair< double,double > > const *)arg1)->back();
@@ -24612,7 +24612,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_assign(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_assign(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::size_type arg2 ;
@@ -24625,25 +24625,25 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_assign(PyObject *self, PyObje
   PyObject *swig_obj[3] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t_assign", 3, 3, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T_assign", 3, 3, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_assign" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_assign" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_t_assign" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_T_assign" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::pair< double,double > >::size_type >(val2);
   {
     std::pair< double,double > *ptr = (std::pair< double,double > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_pvacuum_double_t_assign" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_pvacuum_double_T_assign" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_t_assign" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_T_assign" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -24657,7 +24657,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_resize__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::size_type arg2 ;
@@ -24672,22 +24672,22 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_resize__SWIG_1(PyObject *self
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_resize" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_resize" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_t_resize" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_T_resize" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::pair< double,double > >::size_type >(val2);
   {
     std::pair< double,double > *ptr = (std::pair< double,double > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_pvacuum_double_t_resize" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_pvacuum_double_T_resize" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_t_resize" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_T_resize" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -24701,13 +24701,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_resize(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_resize(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[4] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t_resize", 0, 3, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T_resize", 0, 3, argv))) SWIG_fail;
   --argc;
   if (argc == 2) {
     int _v = 0;
@@ -24719,7 +24719,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_resize(PyObject *self, PyObje
         _v = SWIG_CheckState(res);
       }
       if (_v) {
-        return _wrap_vector_pvacuum_double_t_resize__SWIG_0(self, argc, argv);
+        return _wrap_vector_pvacuum_double_T_resize__SWIG_0(self, argc, argv);
       }
     }
   }
@@ -24736,14 +24736,14 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_resize(PyObject *self, PyObje
         int res = swig::asptr(argv[2], (std::pair< double,double >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vector_pvacuum_double_t_resize__SWIG_1(self, argc, argv);
+          return _wrap_vector_pvacuum_double_T_resize__SWIG_1(self, argc, argv);
         }
       }
     }
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_t_resize'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_T_resize'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::pair< double,double > >::resize(std::vector< std::pair< double,double > >::size_type)\n"
     "    std::vector< std::pair< double,double > >::resize(std::vector< std::pair< double,double > >::size_type,std::vector< std::pair< double,double > >::value_type const &)\n");
@@ -24751,7 +24751,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_insert__SWIG_0(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::iterator arg2 ;
@@ -24767,28 +24767,28 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_insert__SWIG_0(PyObject *self
   if ((nobjs < 3) || (nobjs > 3)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_insert" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_insert" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t_insert" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T_insert" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t_insert" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T_insert" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
     }
   }
   {
     std::pair< double,double > *ptr = (std::pair< double,double > *)0;
     res3 = swig::asptr(swig_obj[2], &ptr);
     if (!SWIG_IsOK(res3)) {
-      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_pvacuum_double_t_insert" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res3), "in method '" "vector_pvacuum_double_T_insert" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_t_insert" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_T_insert" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     arg3 = ptr;
   }
@@ -24803,7 +24803,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_insert__SWIG_1(PyObject *self, Py_ssize_t nobjs, PyObject **swig_obj) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::iterator arg2 ;
@@ -24821,33 +24821,33 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_insert__SWIG_1(PyObject *self
   if ((nobjs < 4) || (nobjs > 4)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_insert" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_insert" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   res2 = SWIG_ConvertPtr(swig_obj[1], SWIG_as_voidptrptr(&iter2), swig::SwigPyIterator::descriptor(), 0);
   if (!SWIG_IsOK(res2) || !iter2) {
-    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t_insert" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
+    SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T_insert" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
   } else {
     swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *iter_t = dynamic_cast<swig::SwigPyIterator_T<std::vector< std::pair< double,double > >::iterator > *>(iter2);
     if (iter_t) {
       arg2 = iter_t->get_current();
     } else {
-      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_t_insert" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
+      SWIG_exception_fail(SWIG_ArgError(SWIG_TypeError), "in method '" "vector_pvacuum_double_T_insert" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::iterator""'");
     }
   }
   ecode3 = SWIG_AsVal_size_t(swig_obj[2], &val3);
   if (!SWIG_IsOK(ecode3)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_pvacuum_double_t_insert" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode3), "in method '" "vector_pvacuum_double_T_insert" "', argument " "3"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
   } 
   arg3 = static_cast< std::vector< std::pair< double,double > >::size_type >(val3);
   {
     std::pair< double,double > *ptr = (std::pair< double,double > *)0;
     res4 = swig::asptr(swig_obj[3], &ptr);
     if (!SWIG_IsOK(res4)) {
-      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_pvacuum_double_t_insert" "', argument " "4"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ArgError(res4), "in method '" "vector_pvacuum_double_T_insert" "', argument " "4"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     if (!ptr) {
-      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_t_insert" "', argument " "4"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
+      SWIG_exception_fail(SWIG_ValueError, "invalid null reference " "in method '" "vector_pvacuum_double_T_insert" "', argument " "4"" of type '" "std::vector< std::pair< double,double > >::value_type const &""'"); 
     }
     arg4 = ptr;
   }
@@ -24861,13 +24861,13 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_insert(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_insert(PyObject *self, PyObject *args) {
   Py_ssize_t argc;
   PyObject *argv[5] = {
     0
   };
   
-  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t_insert", 0, 4, argv))) SWIG_fail;
+  if (!(argc = SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T_insert", 0, 4, argv))) SWIG_fail;
   --argc;
   if (argc == 3) {
     int _v = 0;
@@ -24881,7 +24881,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_insert(PyObject *self, PyObje
         int res = swig::asptr(argv[2], (std::pair< double,double >**)(0));
         _v = SWIG_CheckState(res);
         if (_v) {
-          return _wrap_vector_pvacuum_double_t_insert__SWIG_0(self, argc, argv);
+          return _wrap_vector_pvacuum_double_T_insert__SWIG_0(self, argc, argv);
         }
       }
     }
@@ -24903,7 +24903,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_insert(PyObject *self, PyObje
           int res = swig::asptr(argv[3], (std::pair< double,double >**)(0));
           _v = SWIG_CheckState(res);
           if (_v) {
-            return _wrap_vector_pvacuum_double_t_insert__SWIG_1(self, argc, argv);
+            return _wrap_vector_pvacuum_double_T_insert__SWIG_1(self, argc, argv);
           }
         }
       }
@@ -24911,7 +24911,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_insert(PyObject *self, PyObje
   }
   
 fail:
-  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_t_insert'.\n"
+  SWIG_Python_RaiseOrModifyTypeError("Wrong number or type of arguments for overloaded function 'vector_pvacuum_double_T_insert'.\n"
     "  Possible C/C++ prototypes are:\n"
     "    std::vector< std::pair< double,double > >::insert(std::vector< std::pair< double,double > >::iterator,std::vector< std::pair< double,double > >::value_type const &)\n"
     "    std::vector< std::pair< double,double > >::insert(std::vector< std::pair< double,double > >::iterator,std::vector< std::pair< double,double > >::size_type,std::vector< std::pair< double,double > >::value_type const &)\n");
@@ -24919,7 +24919,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_reserve(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_reserve(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   std::vector< std::pair< double,double > >::size_type arg2 ;
@@ -24930,15 +24930,15 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_reserve(PyObject *self, PyObj
   PyObject *swig_obj[2] ;
   
   (void)self;
-  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_t_reserve", 2, 2, swig_obj)) SWIG_fail;
+  if (!SWIG_Python_UnpackTuple(args, "vector_pvacuum_double_T_reserve", 2, 2, swig_obj)) SWIG_fail;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_reserve" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_reserve" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   ecode2 = SWIG_AsVal_size_t(swig_obj[1], &val2);
   if (!SWIG_IsOK(ecode2)) {
-    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_t_reserve" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
+    SWIG_exception_fail(SWIG_ArgError(ecode2), "in method '" "vector_pvacuum_double_T_reserve" "', argument " "2"" of type '" "std::vector< std::pair< double,double > >::size_type""'");
   } 
   arg2 = static_cast< std::vector< std::pair< double,double > >::size_type >(val2);
   (arg1)->reserve(arg2);
@@ -24949,7 +24949,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_capacity(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_vector_pvacuum_double_T_capacity(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -24962,7 +24962,7 @@ SWIGINTERN PyObject *_wrap_vector_pvacuum_double_t_capacity(PyObject *self, PyOb
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, 0 |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_t_capacity" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "vector_pvacuum_double_T_capacity" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > const *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   result = ((std::vector< std::pair< double,double > > const *)arg1)->capacity();
@@ -24973,7 +24973,7 @@ fail:
 }
 
 
-SWIGINTERN PyObject *_wrap_delete_vector_pvacuum_double_t(PyObject *self, PyObject *args) {
+SWIGINTERN PyObject *_wrap_delete_vector_pvacuum_double_T(PyObject *self, PyObject *args) {
   PyObject *resultobj = 0;
   std::vector< std::pair< double,double > > *arg1 = (std::vector< std::pair< double,double > > *) 0 ;
   void *argp1 = 0 ;
@@ -24985,7 +24985,7 @@ SWIGINTERN PyObject *_wrap_delete_vector_pvacuum_double_t(PyObject *self, PyObje
   swig_obj[0] = args;
   res1 = SWIG_ConvertPtr(swig_obj[0], &argp1,SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, SWIG_POINTER_DISOWN |  0 );
   if (!SWIG_IsOK(res1)) {
-    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vector_pvacuum_double_t" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
+    SWIG_exception_fail(SWIG_ArgError(res1), "in method '" "delete_vector_pvacuum_double_T" "', argument " "1"" of type '" "std::vector< std::pair< double,double > > *""'"); 
   }
   arg1 = reinterpret_cast< std::vector< std::pair< double,double > > * >(argp1);
   {
@@ -25006,14 +25006,14 @@ fail:
 }
 
 
-SWIGINTERN PyObject *vector_pvacuum_double_t_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vector_pvacuum_double_T_swigregister(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   PyObject *obj;
   if (!SWIG_Python_UnpackTuple(args, "swigregister", 1, 1, &obj)) return NULL;
   SWIG_TypeNewClientData(SWIGTYPE_p_std__vectorT_std__pairT_double_double_t_t, SWIG_NewClientData(obj));
   return SWIG_Py_Void();
 }
 
-SWIGINTERN PyObject *vector_pvacuum_double_t_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
+SWIGINTERN PyObject *vector_pvacuum_double_T_swiginit(PyObject *SWIGUNUSEDPARM(self), PyObject *args) {
   return SWIG_Python_InitShadowInstance(args);
 }
 
@@ -38939,558 +38939,558 @@ static PyMethodDef SwigMethods[] = {
 		"SwigPyIterator___sub__(SwigPyIterator self, SwigPyIterator x) -> ptrdiff_t\n"
 		""},
 	 { "SwigPyIterator_swigregister", SwigPyIterator_swigregister, METH_O, NULL},
-	 { "vdouble1d_t_iterator", _wrap_vdouble1d_t_iterator, METH_O, "vdouble1d_t_iterator(vdouble1d_t self) -> SwigPyIterator"},
-	 { "vdouble1d_t___nonzero__", _wrap_vdouble1d_t___nonzero__, METH_O, "vdouble1d_t___nonzero__(vdouble1d_t self) -> bool"},
-	 { "vdouble1d_t___bool__", _wrap_vdouble1d_t___bool__, METH_O, "vdouble1d_t___bool__(vdouble1d_t self) -> bool"},
-	 { "vdouble1d_t___len__", _wrap_vdouble1d_t___len__, METH_O, "vdouble1d_t___len__(vdouble1d_t self) -> std::vector< double >::size_type"},
-	 { "vdouble1d_t___getslice__", _wrap_vdouble1d_t___getslice__, METH_VARARGS, "vdouble1d_t___getslice__(vdouble1d_t self, std::vector< double >::difference_type i, std::vector< double >::difference_type j) -> vdouble1d_t"},
-	 { "vdouble1d_t___setslice__", _wrap_vdouble1d_t___setslice__, METH_VARARGS, "\n"
-		"vdouble1d_t___setslice__(vdouble1d_t self, std::vector< double >::difference_type i, std::vector< double >::difference_type j)\n"
-		"vdouble1d_t___setslice__(vdouble1d_t self, std::vector< double >::difference_type i, std::vector< double >::difference_type j, vdouble1d_t v)\n"
+	 { "vdouble1d_T_iterator", _wrap_vdouble1d_T_iterator, METH_O, "vdouble1d_T_iterator(vdouble1d_T self) -> SwigPyIterator"},
+	 { "vdouble1d_T___nonzero__", _wrap_vdouble1d_T___nonzero__, METH_O, "vdouble1d_T___nonzero__(vdouble1d_T self) -> bool"},
+	 { "vdouble1d_T___bool__", _wrap_vdouble1d_T___bool__, METH_O, "vdouble1d_T___bool__(vdouble1d_T self) -> bool"},
+	 { "vdouble1d_T___len__", _wrap_vdouble1d_T___len__, METH_O, "vdouble1d_T___len__(vdouble1d_T self) -> std::vector< double >::size_type"},
+	 { "vdouble1d_T___getslice__", _wrap_vdouble1d_T___getslice__, METH_VARARGS, "vdouble1d_T___getslice__(vdouble1d_T self, std::vector< double >::difference_type i, std::vector< double >::difference_type j) -> vdouble1d_T"},
+	 { "vdouble1d_T___setslice__", _wrap_vdouble1d_T___setslice__, METH_VARARGS, "\n"
+		"vdouble1d_T___setslice__(vdouble1d_T self, std::vector< double >::difference_type i, std::vector< double >::difference_type j)\n"
+		"vdouble1d_T___setslice__(vdouble1d_T self, std::vector< double >::difference_type i, std::vector< double >::difference_type j, vdouble1d_T v)\n"
 		""},
-	 { "vdouble1d_t___delslice__", _wrap_vdouble1d_t___delslice__, METH_VARARGS, "vdouble1d_t___delslice__(vdouble1d_t self, std::vector< double >::difference_type i, std::vector< double >::difference_type j)"},
-	 { "vdouble1d_t___delitem__", _wrap_vdouble1d_t___delitem__, METH_VARARGS, "\n"
-		"vdouble1d_t___delitem__(vdouble1d_t self, std::vector< double >::difference_type i)\n"
-		"vdouble1d_t___delitem__(vdouble1d_t self, SWIGPY_SLICEOBJECT * slice)\n"
+	 { "vdouble1d_T___delslice__", _wrap_vdouble1d_T___delslice__, METH_VARARGS, "vdouble1d_T___delslice__(vdouble1d_T self, std::vector< double >::difference_type i, std::vector< double >::difference_type j)"},
+	 { "vdouble1d_T___delitem__", _wrap_vdouble1d_T___delitem__, METH_VARARGS, "\n"
+		"vdouble1d_T___delitem__(vdouble1d_T self, std::vector< double >::difference_type i)\n"
+		"vdouble1d_T___delitem__(vdouble1d_T self, SWIGPY_SLICEOBJECT * slice)\n"
 		""},
-	 { "vdouble1d_t___getitem__", _wrap_vdouble1d_t___getitem__, METH_VARARGS, "\n"
-		"vdouble1d_t___getitem__(vdouble1d_t self, SWIGPY_SLICEOBJECT * slice) -> vdouble1d_t\n"
-		"vdouble1d_t___getitem__(vdouble1d_t self, std::vector< double >::difference_type i) -> std::vector< double >::value_type const &\n"
+	 { "vdouble1d_T___getitem__", _wrap_vdouble1d_T___getitem__, METH_VARARGS, "\n"
+		"vdouble1d_T___getitem__(vdouble1d_T self, SWIGPY_SLICEOBJECT * slice) -> vdouble1d_T\n"
+		"vdouble1d_T___getitem__(vdouble1d_T self, std::vector< double >::difference_type i) -> std::vector< double >::value_type const &\n"
 		""},
-	 { "vdouble1d_t___setitem__", _wrap_vdouble1d_t___setitem__, METH_VARARGS, "\n"
-		"vdouble1d_t___setitem__(vdouble1d_t self, SWIGPY_SLICEOBJECT * slice, vdouble1d_t v)\n"
-		"vdouble1d_t___setitem__(vdouble1d_t self, SWIGPY_SLICEOBJECT * slice)\n"
-		"vdouble1d_t___setitem__(vdouble1d_t self, std::vector< double >::difference_type i, std::vector< double >::value_type const & x)\n"
+	 { "vdouble1d_T___setitem__", _wrap_vdouble1d_T___setitem__, METH_VARARGS, "\n"
+		"vdouble1d_T___setitem__(vdouble1d_T self, SWIGPY_SLICEOBJECT * slice, vdouble1d_T v)\n"
+		"vdouble1d_T___setitem__(vdouble1d_T self, SWIGPY_SLICEOBJECT * slice)\n"
+		"vdouble1d_T___setitem__(vdouble1d_T self, std::vector< double >::difference_type i, std::vector< double >::value_type const & x)\n"
 		""},
-	 { "vdouble1d_t_pop", _wrap_vdouble1d_t_pop, METH_O, "vdouble1d_t_pop(vdouble1d_t self) -> std::vector< double >::value_type"},
-	 { "vdouble1d_t_append", _wrap_vdouble1d_t_append, METH_VARARGS, "vdouble1d_t_append(vdouble1d_t self, std::vector< double >::value_type const & x)"},
-	 { "vdouble1d_t_empty", _wrap_vdouble1d_t_empty, METH_O, "vdouble1d_t_empty(vdouble1d_t self) -> bool"},
-	 { "vdouble1d_t_size", _wrap_vdouble1d_t_size, METH_O, "vdouble1d_t_size(vdouble1d_t self) -> std::vector< double >::size_type"},
-	 { "vdouble1d_t_swap", _wrap_vdouble1d_t_swap, METH_VARARGS, "vdouble1d_t_swap(vdouble1d_t self, vdouble1d_t v)"},
-	 { "vdouble1d_t_begin", _wrap_vdouble1d_t_begin, METH_O, "vdouble1d_t_begin(vdouble1d_t self) -> std::vector< double >::iterator"},
-	 { "vdouble1d_t_end", _wrap_vdouble1d_t_end, METH_O, "vdouble1d_t_end(vdouble1d_t self) -> std::vector< double >::iterator"},
-	 { "vdouble1d_t_rbegin", _wrap_vdouble1d_t_rbegin, METH_O, "vdouble1d_t_rbegin(vdouble1d_t self) -> std::vector< double >::reverse_iterator"},
-	 { "vdouble1d_t_rend", _wrap_vdouble1d_t_rend, METH_O, "vdouble1d_t_rend(vdouble1d_t self) -> std::vector< double >::reverse_iterator"},
-	 { "vdouble1d_t_clear", _wrap_vdouble1d_t_clear, METH_O, "vdouble1d_t_clear(vdouble1d_t self)"},
-	 { "vdouble1d_t_get_allocator", _wrap_vdouble1d_t_get_allocator, METH_O, "vdouble1d_t_get_allocator(vdouble1d_t self) -> std::vector< double >::allocator_type"},
-	 { "vdouble1d_t_pop_back", _wrap_vdouble1d_t_pop_back, METH_O, "vdouble1d_t_pop_back(vdouble1d_t self)"},
-	 { "vdouble1d_t_erase", _wrap_vdouble1d_t_erase, METH_VARARGS, "\n"
-		"vdouble1d_t_erase(vdouble1d_t self, std::vector< double >::iterator pos) -> std::vector< double >::iterator\n"
-		"vdouble1d_t_erase(vdouble1d_t self, std::vector< double >::iterator first, std::vector< double >::iterator last) -> std::vector< double >::iterator\n"
+	 { "vdouble1d_T_pop", _wrap_vdouble1d_T_pop, METH_O, "vdouble1d_T_pop(vdouble1d_T self) -> std::vector< double >::value_type"},
+	 { "vdouble1d_T_append", _wrap_vdouble1d_T_append, METH_VARARGS, "vdouble1d_T_append(vdouble1d_T self, std::vector< double >::value_type const & x)"},
+	 { "vdouble1d_T_empty", _wrap_vdouble1d_T_empty, METH_O, "vdouble1d_T_empty(vdouble1d_T self) -> bool"},
+	 { "vdouble1d_T_size", _wrap_vdouble1d_T_size, METH_O, "vdouble1d_T_size(vdouble1d_T self) -> std::vector< double >::size_type"},
+	 { "vdouble1d_T_swap", _wrap_vdouble1d_T_swap, METH_VARARGS, "vdouble1d_T_swap(vdouble1d_T self, vdouble1d_T v)"},
+	 { "vdouble1d_T_begin", _wrap_vdouble1d_T_begin, METH_O, "vdouble1d_T_begin(vdouble1d_T self) -> std::vector< double >::iterator"},
+	 { "vdouble1d_T_end", _wrap_vdouble1d_T_end, METH_O, "vdouble1d_T_end(vdouble1d_T self) -> std::vector< double >::iterator"},
+	 { "vdouble1d_T_rbegin", _wrap_vdouble1d_T_rbegin, METH_O, "vdouble1d_T_rbegin(vdouble1d_T self) -> std::vector< double >::reverse_iterator"},
+	 { "vdouble1d_T_rend", _wrap_vdouble1d_T_rend, METH_O, "vdouble1d_T_rend(vdouble1d_T self) -> std::vector< double >::reverse_iterator"},
+	 { "vdouble1d_T_clear", _wrap_vdouble1d_T_clear, METH_O, "vdouble1d_T_clear(vdouble1d_T self)"},
+	 { "vdouble1d_T_get_allocator", _wrap_vdouble1d_T_get_allocator, METH_O, "vdouble1d_T_get_allocator(vdouble1d_T self) -> std::vector< double >::allocator_type"},
+	 { "vdouble1d_T_pop_back", _wrap_vdouble1d_T_pop_back, METH_O, "vdouble1d_T_pop_back(vdouble1d_T self)"},
+	 { "vdouble1d_T_erase", _wrap_vdouble1d_T_erase, METH_VARARGS, "\n"
+		"vdouble1d_T_erase(vdouble1d_T self, std::vector< double >::iterator pos) -> std::vector< double >::iterator\n"
+		"vdouble1d_T_erase(vdouble1d_T self, std::vector< double >::iterator first, std::vector< double >::iterator last) -> std::vector< double >::iterator\n"
 		""},
-	 { "new_vdouble1d_t", _wrap_new_vdouble1d_t, METH_VARARGS, "\n"
-		"vdouble1d_t()\n"
-		"vdouble1d_t(vdouble1d_t other)\n"
-		"vdouble1d_t(std::vector< double >::size_type size)\n"
-		"new_vdouble1d_t(std::vector< double >::size_type size, std::vector< double >::value_type const & value) -> vdouble1d_t\n"
+	 { "new_vdouble1d_T", _wrap_new_vdouble1d_T, METH_VARARGS, "\n"
+		"vdouble1d_T()\n"
+		"vdouble1d_T(vdouble1d_T other)\n"
+		"vdouble1d_T(std::vector< double >::size_type size)\n"
+		"new_vdouble1d_T(std::vector< double >::size_type size, std::vector< double >::value_type const & value) -> vdouble1d_T\n"
 		""},
-	 { "vdouble1d_t_push_back", _wrap_vdouble1d_t_push_back, METH_VARARGS, "vdouble1d_t_push_back(vdouble1d_t self, std::vector< double >::value_type const & x)"},
-	 { "vdouble1d_t_front", _wrap_vdouble1d_t_front, METH_O, "vdouble1d_t_front(vdouble1d_t self) -> std::vector< double >::value_type const &"},
-	 { "vdouble1d_t_back", _wrap_vdouble1d_t_back, METH_O, "vdouble1d_t_back(vdouble1d_t self) -> std::vector< double >::value_type const &"},
-	 { "vdouble1d_t_assign", _wrap_vdouble1d_t_assign, METH_VARARGS, "vdouble1d_t_assign(vdouble1d_t self, std::vector< double >::size_type n, std::vector< double >::value_type const & x)"},
-	 { "vdouble1d_t_resize", _wrap_vdouble1d_t_resize, METH_VARARGS, "\n"
-		"vdouble1d_t_resize(vdouble1d_t self, std::vector< double >::size_type new_size)\n"
-		"vdouble1d_t_resize(vdouble1d_t self, std::vector< double >::size_type new_size, std::vector< double >::value_type const & x)\n"
+	 { "vdouble1d_T_push_back", _wrap_vdouble1d_T_push_back, METH_VARARGS, "vdouble1d_T_push_back(vdouble1d_T self, std::vector< double >::value_type const & x)"},
+	 { "vdouble1d_T_front", _wrap_vdouble1d_T_front, METH_O, "vdouble1d_T_front(vdouble1d_T self) -> std::vector< double >::value_type const &"},
+	 { "vdouble1d_T_back", _wrap_vdouble1d_T_back, METH_O, "vdouble1d_T_back(vdouble1d_T self) -> std::vector< double >::value_type const &"},
+	 { "vdouble1d_T_assign", _wrap_vdouble1d_T_assign, METH_VARARGS, "vdouble1d_T_assign(vdouble1d_T self, std::vector< double >::size_type n, std::vector< double >::value_type const & x)"},
+	 { "vdouble1d_T_resize", _wrap_vdouble1d_T_resize, METH_VARARGS, "\n"
+		"vdouble1d_T_resize(vdouble1d_T self, std::vector< double >::size_type new_size)\n"
+		"vdouble1d_T_resize(vdouble1d_T self, std::vector< double >::size_type new_size, std::vector< double >::value_type const & x)\n"
 		""},
-	 { "vdouble1d_t_insert", _wrap_vdouble1d_t_insert, METH_VARARGS, "\n"
-		"vdouble1d_t_insert(vdouble1d_t self, std::vector< double >::iterator pos, std::vector< double >::value_type const & x) -> std::vector< double >::iterator\n"
-		"vdouble1d_t_insert(vdouble1d_t self, std::vector< double >::iterator pos, std::vector< double >::size_type n, std::vector< double >::value_type const & x)\n"
+	 { "vdouble1d_T_insert", _wrap_vdouble1d_T_insert, METH_VARARGS, "\n"
+		"vdouble1d_T_insert(vdouble1d_T self, std::vector< double >::iterator pos, std::vector< double >::value_type const & x) -> std::vector< double >::iterator\n"
+		"vdouble1d_T_insert(vdouble1d_T self, std::vector< double >::iterator pos, std::vector< double >::size_type n, std::vector< double >::value_type const & x)\n"
 		""},
-	 { "vdouble1d_t_reserve", _wrap_vdouble1d_t_reserve, METH_VARARGS, "vdouble1d_t_reserve(vdouble1d_t self, std::vector< double >::size_type n)"},
-	 { "vdouble1d_t_capacity", _wrap_vdouble1d_t_capacity, METH_O, "vdouble1d_t_capacity(vdouble1d_t self) -> std::vector< double >::size_type"},
-	 { "delete_vdouble1d_t", _wrap_delete_vdouble1d_t, METH_O, "delete_vdouble1d_t(vdouble1d_t self)"},
-	 { "vdouble1d_t_swigregister", vdouble1d_t_swigregister, METH_O, NULL},
-	 { "vdouble1d_t_swiginit", vdouble1d_t_swiginit, METH_VARARGS, NULL},
-	 { "vdouble2d_t_iterator", _wrap_vdouble2d_t_iterator, METH_O, "vdouble2d_t_iterator(vdouble2d_t self) -> SwigPyIterator"},
-	 { "vdouble2d_t___nonzero__", _wrap_vdouble2d_t___nonzero__, METH_O, "vdouble2d_t___nonzero__(vdouble2d_t self) -> bool"},
-	 { "vdouble2d_t___bool__", _wrap_vdouble2d_t___bool__, METH_O, "vdouble2d_t___bool__(vdouble2d_t self) -> bool"},
-	 { "vdouble2d_t___len__", _wrap_vdouble2d_t___len__, METH_O, "vdouble2d_t___len__(vdouble2d_t self) -> std::vector< std::vector< double > >::size_type"},
-	 { "vdouble2d_t___getslice__", _wrap_vdouble2d_t___getslice__, METH_VARARGS, "vdouble2d_t___getslice__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j) -> vdouble2d_t"},
-	 { "vdouble2d_t___setslice__", _wrap_vdouble2d_t___setslice__, METH_VARARGS, "\n"
-		"vdouble2d_t___setslice__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j)\n"
-		"vdouble2d_t___setslice__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j, vdouble2d_t v)\n"
+	 { "vdouble1d_T_reserve", _wrap_vdouble1d_T_reserve, METH_VARARGS, "vdouble1d_T_reserve(vdouble1d_T self, std::vector< double >::size_type n)"},
+	 { "vdouble1d_T_capacity", _wrap_vdouble1d_T_capacity, METH_O, "vdouble1d_T_capacity(vdouble1d_T self) -> std::vector< double >::size_type"},
+	 { "delete_vdouble1d_T", _wrap_delete_vdouble1d_T, METH_O, "delete_vdouble1d_T(vdouble1d_T self)"},
+	 { "vdouble1d_T_swigregister", vdouble1d_T_swigregister, METH_O, NULL},
+	 { "vdouble1d_T_swiginit", vdouble1d_T_swiginit, METH_VARARGS, NULL},
+	 { "vdouble2d_T_iterator", _wrap_vdouble2d_T_iterator, METH_O, "vdouble2d_T_iterator(vdouble2d_T self) -> SwigPyIterator"},
+	 { "vdouble2d_T___nonzero__", _wrap_vdouble2d_T___nonzero__, METH_O, "vdouble2d_T___nonzero__(vdouble2d_T self) -> bool"},
+	 { "vdouble2d_T___bool__", _wrap_vdouble2d_T___bool__, METH_O, "vdouble2d_T___bool__(vdouble2d_T self) -> bool"},
+	 { "vdouble2d_T___len__", _wrap_vdouble2d_T___len__, METH_O, "vdouble2d_T___len__(vdouble2d_T self) -> std::vector< std::vector< double > >::size_type"},
+	 { "vdouble2d_T___getslice__", _wrap_vdouble2d_T___getslice__, METH_VARARGS, "vdouble2d_T___getslice__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j) -> vdouble2d_T"},
+	 { "vdouble2d_T___setslice__", _wrap_vdouble2d_T___setslice__, METH_VARARGS, "\n"
+		"vdouble2d_T___setslice__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j)\n"
+		"vdouble2d_T___setslice__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j, vdouble2d_T v)\n"
 		""},
-	 { "vdouble2d_t___delslice__", _wrap_vdouble2d_t___delslice__, METH_VARARGS, "vdouble2d_t___delslice__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j)"},
-	 { "vdouble2d_t___delitem__", _wrap_vdouble2d_t___delitem__, METH_VARARGS, "\n"
-		"vdouble2d_t___delitem__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i)\n"
-		"vdouble2d_t___delitem__(vdouble2d_t self, SWIGPY_SLICEOBJECT * slice)\n"
+	 { "vdouble2d_T___delslice__", _wrap_vdouble2d_T___delslice__, METH_VARARGS, "vdouble2d_T___delslice__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i, std::vector< std::vector< double > >::difference_type j)"},
+	 { "vdouble2d_T___delitem__", _wrap_vdouble2d_T___delitem__, METH_VARARGS, "\n"
+		"vdouble2d_T___delitem__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i)\n"
+		"vdouble2d_T___delitem__(vdouble2d_T self, SWIGPY_SLICEOBJECT * slice)\n"
 		""},
-	 { "vdouble2d_t___getitem__", _wrap_vdouble2d_t___getitem__, METH_VARARGS, "\n"
-		"vdouble2d_t___getitem__(vdouble2d_t self, SWIGPY_SLICEOBJECT * slice) -> vdouble2d_t\n"
-		"vdouble2d_t___getitem__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i) -> vdouble1d_t\n"
+	 { "vdouble2d_T___getitem__", _wrap_vdouble2d_T___getitem__, METH_VARARGS, "\n"
+		"vdouble2d_T___getitem__(vdouble2d_T self, SWIGPY_SLICEOBJECT * slice) -> vdouble2d_T\n"
+		"vdouble2d_T___getitem__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i) -> vdouble1d_T\n"
 		""},
-	 { "vdouble2d_t___setitem__", _wrap_vdouble2d_t___setitem__, METH_VARARGS, "\n"
-		"vdouble2d_t___setitem__(vdouble2d_t self, SWIGPY_SLICEOBJECT * slice, vdouble2d_t v)\n"
-		"vdouble2d_t___setitem__(vdouble2d_t self, SWIGPY_SLICEOBJECT * slice)\n"
-		"vdouble2d_t___setitem__(vdouble2d_t self, std::vector< std::vector< double > >::difference_type i, vdouble1d_t x)\n"
+	 { "vdouble2d_T___setitem__", _wrap_vdouble2d_T___setitem__, METH_VARARGS, "\n"
+		"vdouble2d_T___setitem__(vdouble2d_T self, SWIGPY_SLICEOBJECT * slice, vdouble2d_T v)\n"
+		"vdouble2d_T___setitem__(vdouble2d_T self, SWIGPY_SLICEOBJECT * slice)\n"
+		"vdouble2d_T___setitem__(vdouble2d_T self, std::vector< std::vector< double > >::difference_type i, vdouble1d_T x)\n"
 		""},
-	 { "vdouble2d_t_pop", _wrap_vdouble2d_t_pop, METH_O, "vdouble2d_t_pop(vdouble2d_t self) -> vdouble1d_t"},
-	 { "vdouble2d_t_append", _wrap_vdouble2d_t_append, METH_VARARGS, "vdouble2d_t_append(vdouble2d_t self, vdouble1d_t x)"},
-	 { "vdouble2d_t_empty", _wrap_vdouble2d_t_empty, METH_O, "vdouble2d_t_empty(vdouble2d_t self) -> bool"},
-	 { "vdouble2d_t_size", _wrap_vdouble2d_t_size, METH_O, "vdouble2d_t_size(vdouble2d_t self) -> std::vector< std::vector< double > >::size_type"},
-	 { "vdouble2d_t_swap", _wrap_vdouble2d_t_swap, METH_VARARGS, "vdouble2d_t_swap(vdouble2d_t self, vdouble2d_t v)"},
-	 { "vdouble2d_t_begin", _wrap_vdouble2d_t_begin, METH_O, "vdouble2d_t_begin(vdouble2d_t self) -> std::vector< std::vector< double > >::iterator"},
-	 { "vdouble2d_t_end", _wrap_vdouble2d_t_end, METH_O, "vdouble2d_t_end(vdouble2d_t self) -> std::vector< std::vector< double > >::iterator"},
-	 { "vdouble2d_t_rbegin", _wrap_vdouble2d_t_rbegin, METH_O, "vdouble2d_t_rbegin(vdouble2d_t self) -> std::vector< std::vector< double > >::reverse_iterator"},
-	 { "vdouble2d_t_rend", _wrap_vdouble2d_t_rend, METH_O, "vdouble2d_t_rend(vdouble2d_t self) -> std::vector< std::vector< double > >::reverse_iterator"},
-	 { "vdouble2d_t_clear", _wrap_vdouble2d_t_clear, METH_O, "vdouble2d_t_clear(vdouble2d_t self)"},
-	 { "vdouble2d_t_get_allocator", _wrap_vdouble2d_t_get_allocator, METH_O, "vdouble2d_t_get_allocator(vdouble2d_t self) -> std::vector< std::vector< double > >::allocator_type"},
-	 { "vdouble2d_t_pop_back", _wrap_vdouble2d_t_pop_back, METH_O, "vdouble2d_t_pop_back(vdouble2d_t self)"},
-	 { "vdouble2d_t_erase", _wrap_vdouble2d_t_erase, METH_VARARGS, "\n"
-		"vdouble2d_t_erase(vdouble2d_t self, std::vector< std::vector< double > >::iterator pos) -> std::vector< std::vector< double > >::iterator\n"
-		"vdouble2d_t_erase(vdouble2d_t self, std::vector< std::vector< double > >::iterator first, std::vector< std::vector< double > >::iterator last) -> std::vector< std::vector< double > >::iterator\n"
+	 { "vdouble2d_T_pop", _wrap_vdouble2d_T_pop, METH_O, "vdouble2d_T_pop(vdouble2d_T self) -> vdouble1d_T"},
+	 { "vdouble2d_T_append", _wrap_vdouble2d_T_append, METH_VARARGS, "vdouble2d_T_append(vdouble2d_T self, vdouble1d_T x)"},
+	 { "vdouble2d_T_empty", _wrap_vdouble2d_T_empty, METH_O, "vdouble2d_T_empty(vdouble2d_T self) -> bool"},
+	 { "vdouble2d_T_size", _wrap_vdouble2d_T_size, METH_O, "vdouble2d_T_size(vdouble2d_T self) -> std::vector< std::vector< double > >::size_type"},
+	 { "vdouble2d_T_swap", _wrap_vdouble2d_T_swap, METH_VARARGS, "vdouble2d_T_swap(vdouble2d_T self, vdouble2d_T v)"},
+	 { "vdouble2d_T_begin", _wrap_vdouble2d_T_begin, METH_O, "vdouble2d_T_begin(vdouble2d_T self) -> std::vector< std::vector< double > >::iterator"},
+	 { "vdouble2d_T_end", _wrap_vdouble2d_T_end, METH_O, "vdouble2d_T_end(vdouble2d_T self) -> std::vector< std::vector< double > >::iterator"},
+	 { "vdouble2d_T_rbegin", _wrap_vdouble2d_T_rbegin, METH_O, "vdouble2d_T_rbegin(vdouble2d_T self) -> std::vector< std::vector< double > >::reverse_iterator"},
+	 { "vdouble2d_T_rend", _wrap_vdouble2d_T_rend, METH_O, "vdouble2d_T_rend(vdouble2d_T self) -> std::vector< std::vector< double > >::reverse_iterator"},
+	 { "vdouble2d_T_clear", _wrap_vdouble2d_T_clear, METH_O, "vdouble2d_T_clear(vdouble2d_T self)"},
+	 { "vdouble2d_T_get_allocator", _wrap_vdouble2d_T_get_allocator, METH_O, "vdouble2d_T_get_allocator(vdouble2d_T self) -> std::vector< std::vector< double > >::allocator_type"},
+	 { "vdouble2d_T_pop_back", _wrap_vdouble2d_T_pop_back, METH_O, "vdouble2d_T_pop_back(vdouble2d_T self)"},
+	 { "vdouble2d_T_erase", _wrap_vdouble2d_T_erase, METH_VARARGS, "\n"
+		"vdouble2d_T_erase(vdouble2d_T self, std::vector< std::vector< double > >::iterator pos) -> std::vector< std::vector< double > >::iterator\n"
+		"vdouble2d_T_erase(vdouble2d_T self, std::vector< std::vector< double > >::iterator first, std::vector< std::vector< double > >::iterator last) -> std::vector< std::vector< double > >::iterator\n"
 		""},
-	 { "new_vdouble2d_t", _wrap_new_vdouble2d_t, METH_VARARGS, "\n"
-		"vdouble2d_t()\n"
-		"vdouble2d_t(vdouble2d_t other)\n"
-		"vdouble2d_t(std::vector< std::vector< double > >::size_type size)\n"
-		"new_vdouble2d_t(std::vector< std::vector< double > >::size_type size, vdouble1d_t value) -> vdouble2d_t\n"
+	 { "new_vdouble2d_T", _wrap_new_vdouble2d_T, METH_VARARGS, "\n"
+		"vdouble2d_T()\n"
+		"vdouble2d_T(vdouble2d_T other)\n"
+		"vdouble2d_T(std::vector< std::vector< double > >::size_type size)\n"
+		"new_vdouble2d_T(std::vector< std::vector< double > >::size_type size, vdouble1d_T value) -> vdouble2d_T\n"
 		""},
-	 { "vdouble2d_t_push_back", _wrap_vdouble2d_t_push_back, METH_VARARGS, "vdouble2d_t_push_back(vdouble2d_t self, vdouble1d_t x)"},
-	 { "vdouble2d_t_front", _wrap_vdouble2d_t_front, METH_O, "vdouble2d_t_front(vdouble2d_t self) -> vdouble1d_t"},
-	 { "vdouble2d_t_back", _wrap_vdouble2d_t_back, METH_O, "vdouble2d_t_back(vdouble2d_t self) -> vdouble1d_t"},
-	 { "vdouble2d_t_assign", _wrap_vdouble2d_t_assign, METH_VARARGS, "vdouble2d_t_assign(vdouble2d_t self, std::vector< std::vector< double > >::size_type n, vdouble1d_t x)"},
-	 { "vdouble2d_t_resize", _wrap_vdouble2d_t_resize, METH_VARARGS, "\n"
-		"vdouble2d_t_resize(vdouble2d_t self, std::vector< std::vector< double > >::size_type new_size)\n"
-		"vdouble2d_t_resize(vdouble2d_t self, std::vector< std::vector< double > >::size_type new_size, vdouble1d_t x)\n"
+	 { "vdouble2d_T_push_back", _wrap_vdouble2d_T_push_back, METH_VARARGS, "vdouble2d_T_push_back(vdouble2d_T self, vdouble1d_T x)"},
+	 { "vdouble2d_T_front", _wrap_vdouble2d_T_front, METH_O, "vdouble2d_T_front(vdouble2d_T self) -> vdouble1d_T"},
+	 { "vdouble2d_T_back", _wrap_vdouble2d_T_back, METH_O, "vdouble2d_T_back(vdouble2d_T self) -> vdouble1d_T"},
+	 { "vdouble2d_T_assign", _wrap_vdouble2d_T_assign, METH_VARARGS, "vdouble2d_T_assign(vdouble2d_T self, std::vector< std::vector< double > >::size_type n, vdouble1d_T x)"},
+	 { "vdouble2d_T_resize", _wrap_vdouble2d_T_resize, METH_VARARGS, "\n"
+		"vdouble2d_T_resize(vdouble2d_T self, std::vector< std::vector< double > >::size_type new_size)\n"
+		"vdouble2d_T_resize(vdouble2d_T self, std::vector< std::vector< double > >::size_type new_size, vdouble1d_T x)\n"
 		""},
-	 { "vdouble2d_t_insert", _wrap_vdouble2d_t_insert, METH_VARARGS, "\n"
-		"vdouble2d_t_insert(vdouble2d_t self, std::vector< std::vector< double > >::iterator pos, vdouble1d_t x) -> std::vector< std::vector< double > >::iterator\n"
-		"vdouble2d_t_insert(vdouble2d_t self, std::vector< std::vector< double > >::iterator pos, std::vector< std::vector< double > >::size_type n, vdouble1d_t x)\n"
+	 { "vdouble2d_T_insert", _wrap_vdouble2d_T_insert, METH_VARARGS, "\n"
+		"vdouble2d_T_insert(vdouble2d_T self, std::vector< std::vector< double > >::iterator pos, vdouble1d_T x) -> std::vector< std::vector< double > >::iterator\n"
+		"vdouble2d_T_insert(vdouble2d_T self, std::vector< std::vector< double > >::iterator pos, std::vector< std::vector< double > >::size_type n, vdouble1d_T x)\n"
 		""},
-	 { "vdouble2d_t_reserve", _wrap_vdouble2d_t_reserve, METH_VARARGS, "vdouble2d_t_reserve(vdouble2d_t self, std::vector< std::vector< double > >::size_type n)"},
-	 { "vdouble2d_t_capacity", _wrap_vdouble2d_t_capacity, METH_O, "vdouble2d_t_capacity(vdouble2d_t self) -> std::vector< std::vector< double > >::size_type"},
-	 { "delete_vdouble2d_t", _wrap_delete_vdouble2d_t, METH_O, "delete_vdouble2d_t(vdouble2d_t self)"},
-	 { "vdouble2d_t_swigregister", vdouble2d_t_swigregister, METH_O, NULL},
-	 { "vdouble2d_t_swiginit", vdouble2d_t_swiginit, METH_VARARGS, NULL},
-	 { "vector_integer_t_iterator", _wrap_vector_integer_t_iterator, METH_O, "vector_integer_t_iterator(vector_integer_t self) -> SwigPyIterator"},
-	 { "vector_integer_t___nonzero__", _wrap_vector_integer_t___nonzero__, METH_O, "vector_integer_t___nonzero__(vector_integer_t self) -> bool"},
-	 { "vector_integer_t___bool__", _wrap_vector_integer_t___bool__, METH_O, "vector_integer_t___bool__(vector_integer_t self) -> bool"},
-	 { "vector_integer_t___len__", _wrap_vector_integer_t___len__, METH_O, "vector_integer_t___len__(vector_integer_t self) -> std::vector< int >::size_type"},
-	 { "vector_integer_t___getslice__", _wrap_vector_integer_t___getslice__, METH_VARARGS, "vector_integer_t___getslice__(vector_integer_t self, std::vector< int >::difference_type i, std::vector< int >::difference_type j) -> vector_integer_t"},
-	 { "vector_integer_t___setslice__", _wrap_vector_integer_t___setslice__, METH_VARARGS, "\n"
-		"vector_integer_t___setslice__(vector_integer_t self, std::vector< int >::difference_type i, std::vector< int >::difference_type j)\n"
-		"vector_integer_t___setslice__(vector_integer_t self, std::vector< int >::difference_type i, std::vector< int >::difference_type j, vector_integer_t v)\n"
+	 { "vdouble2d_T_reserve", _wrap_vdouble2d_T_reserve, METH_VARARGS, "vdouble2d_T_reserve(vdouble2d_T self, std::vector< std::vector< double > >::size_type n)"},
+	 { "vdouble2d_T_capacity", _wrap_vdouble2d_T_capacity, METH_O, "vdouble2d_T_capacity(vdouble2d_T self) -> std::vector< std::vector< double > >::size_type"},
+	 { "delete_vdouble2d_T", _wrap_delete_vdouble2d_T, METH_O, "delete_vdouble2d_T(vdouble2d_T self)"},
+	 { "vdouble2d_T_swigregister", vdouble2d_T_swigregister, METH_O, NULL},
+	 { "vdouble2d_T_swiginit", vdouble2d_T_swiginit, METH_VARARGS, NULL},
+	 { "vector_integer_T_iterator", _wrap_vector_integer_T_iterator, METH_O, "vector_integer_T_iterator(vector_integer_T self) -> SwigPyIterator"},
+	 { "vector_integer_T___nonzero__", _wrap_vector_integer_T___nonzero__, METH_O, "vector_integer_T___nonzero__(vector_integer_T self) -> bool"},
+	 { "vector_integer_T___bool__", _wrap_vector_integer_T___bool__, METH_O, "vector_integer_T___bool__(vector_integer_T self) -> bool"},
+	 { "vector_integer_T___len__", _wrap_vector_integer_T___len__, METH_O, "vector_integer_T___len__(vector_integer_T self) -> std::vector< int >::size_type"},
+	 { "vector_integer_T___getslice__", _wrap_vector_integer_T___getslice__, METH_VARARGS, "vector_integer_T___getslice__(vector_integer_T self, std::vector< int >::difference_type i, std::vector< int >::difference_type j) -> vector_integer_T"},
+	 { "vector_integer_T___setslice__", _wrap_vector_integer_T___setslice__, METH_VARARGS, "\n"
+		"vector_integer_T___setslice__(vector_integer_T self, std::vector< int >::difference_type i, std::vector< int >::difference_type j)\n"
+		"vector_integer_T___setslice__(vector_integer_T self, std::vector< int >::difference_type i, std::vector< int >::difference_type j, vector_integer_T v)\n"
 		""},
-	 { "vector_integer_t___delslice__", _wrap_vector_integer_t___delslice__, METH_VARARGS, "vector_integer_t___delslice__(vector_integer_t self, std::vector< int >::difference_type i, std::vector< int >::difference_type j)"},
-	 { "vector_integer_t___delitem__", _wrap_vector_integer_t___delitem__, METH_VARARGS, "\n"
-		"vector_integer_t___delitem__(vector_integer_t self, std::vector< int >::difference_type i)\n"
-		"vector_integer_t___delitem__(vector_integer_t self, SWIGPY_SLICEOBJECT * slice)\n"
+	 { "vector_integer_T___delslice__", _wrap_vector_integer_T___delslice__, METH_VARARGS, "vector_integer_T___delslice__(vector_integer_T self, std::vector< int >::difference_type i, std::vector< int >::difference_type j)"},
+	 { "vector_integer_T___delitem__", _wrap_vector_integer_T___delitem__, METH_VARARGS, "\n"
+		"vector_integer_T___delitem__(vector_integer_T self, std::vector< int >::difference_type i)\n"
+		"vector_integer_T___delitem__(vector_integer_T self, SWIGPY_SLICEOBJECT * slice)\n"
 		""},
-	 { "vector_integer_t___getitem__", _wrap_vector_integer_t___getitem__, METH_VARARGS, "\n"
-		"vector_integer_t___getitem__(vector_integer_t self, SWIGPY_SLICEOBJECT * slice) -> vector_integer_t\n"
-		"vector_integer_t___getitem__(vector_integer_t self, std::vector< int >::difference_type i) -> std::vector< int >::value_type const &\n"
+	 { "vector_integer_T___getitem__", _wrap_vector_integer_T___getitem__, METH_VARARGS, "\n"
+		"vector_integer_T___getitem__(vector_integer_T self, SWIGPY_SLICEOBJECT * slice) -> vector_integer_T\n"
+		"vector_integer_T___getitem__(vector_integer_T self, std::vector< int >::difference_type i) -> std::vector< int >::value_type const &\n"
 		""},
-	 { "vector_integer_t___setitem__", _wrap_vector_integer_t___setitem__, METH_VARARGS, "\n"
-		"vector_integer_t___setitem__(vector_integer_t self, SWIGPY_SLICEOBJECT * slice, vector_integer_t v)\n"
-		"vector_integer_t___setitem__(vector_integer_t self, SWIGPY_SLICEOBJECT * slice)\n"
-		"vector_integer_t___setitem__(vector_integer_t self, std::vector< int >::difference_type i, std::vector< int >::value_type const & x)\n"
+	 { "vector_integer_T___setitem__", _wrap_vector_integer_T___setitem__, METH_VARARGS, "\n"
+		"vector_integer_T___setitem__(vector_integer_T self, SWIGPY_SLICEOBJECT * slice, vector_integer_T v)\n"
+		"vector_integer_T___setitem__(vector_integer_T self, SWIGPY_SLICEOBJECT * slice)\n"
+		"vector_integer_T___setitem__(vector_integer_T self, std::vector< int >::difference_type i, std::vector< int >::value_type const & x)\n"
 		""},
-	 { "vector_integer_t_pop", _wrap_vector_integer_t_pop, METH_O, "vector_integer_t_pop(vector_integer_t self) -> std::vector< int >::value_type"},
-	 { "vector_integer_t_append", _wrap_vector_integer_t_append, METH_VARARGS, "vector_integer_t_append(vector_integer_t self, std::vector< int >::value_type const & x)"},
-	 { "vector_integer_t_empty", _wrap_vector_integer_t_empty, METH_O, "vector_integer_t_empty(vector_integer_t self) -> bool"},
-	 { "vector_integer_t_size", _wrap_vector_integer_t_size, METH_O, "vector_integer_t_size(vector_integer_t self) -> std::vector< int >::size_type"},
-	 { "vector_integer_t_swap", _wrap_vector_integer_t_swap, METH_VARARGS, "vector_integer_t_swap(vector_integer_t self, vector_integer_t v)"},
-	 { "vector_integer_t_begin", _wrap_vector_integer_t_begin, METH_O, "vector_integer_t_begin(vector_integer_t self) -> std::vector< int >::iterator"},
-	 { "vector_integer_t_end", _wrap_vector_integer_t_end, METH_O, "vector_integer_t_end(vector_integer_t self) -> std::vector< int >::iterator"},
-	 { "vector_integer_t_rbegin", _wrap_vector_integer_t_rbegin, METH_O, "vector_integer_t_rbegin(vector_integer_t self) -> std::vector< int >::reverse_iterator"},
-	 { "vector_integer_t_rend", _wrap_vector_integer_t_rend, METH_O, "vector_integer_t_rend(vector_integer_t self) -> std::vector< int >::reverse_iterator"},
-	 { "vector_integer_t_clear", _wrap_vector_integer_t_clear, METH_O, "vector_integer_t_clear(vector_integer_t self)"},
-	 { "vector_integer_t_get_allocator", _wrap_vector_integer_t_get_allocator, METH_O, "vector_integer_t_get_allocator(vector_integer_t self) -> std::vector< int >::allocator_type"},
-	 { "vector_integer_t_pop_back", _wrap_vector_integer_t_pop_back, METH_O, "vector_integer_t_pop_back(vector_integer_t self)"},
-	 { "vector_integer_t_erase", _wrap_vector_integer_t_erase, METH_VARARGS, "\n"
-		"vector_integer_t_erase(vector_integer_t self, std::vector< int >::iterator pos) -> std::vector< int >::iterator\n"
-		"vector_integer_t_erase(vector_integer_t self, std::vector< int >::iterator first, std::vector< int >::iterator last) -> std::vector< int >::iterator\n"
+	 { "vector_integer_T_pop", _wrap_vector_integer_T_pop, METH_O, "vector_integer_T_pop(vector_integer_T self) -> std::vector< int >::value_type"},
+	 { "vector_integer_T_append", _wrap_vector_integer_T_append, METH_VARARGS, "vector_integer_T_append(vector_integer_T self, std::vector< int >::value_type const & x)"},
+	 { "vector_integer_T_empty", _wrap_vector_integer_T_empty, METH_O, "vector_integer_T_empty(vector_integer_T self) -> bool"},
+	 { "vector_integer_T_size", _wrap_vector_integer_T_size, METH_O, "vector_integer_T_size(vector_integer_T self) -> std::vector< int >::size_type"},
+	 { "vector_integer_T_swap", _wrap_vector_integer_T_swap, METH_VARARGS, "vector_integer_T_swap(vector_integer_T self, vector_integer_T v)"},
+	 { "vector_integer_T_begin", _wrap_vector_integer_T_begin, METH_O, "vector_integer_T_begin(vector_integer_T self) -> std::vector< int >::iterator"},
+	 { "vector_integer_T_end", _wrap_vector_integer_T_end, METH_O, "vector_integer_T_end(vector_integer_T self) -> std::vector< int >::iterator"},
+	 { "vector_integer_T_rbegin", _wrap_vector_integer_T_rbegin, METH_O, "vector_integer_T_rbegin(vector_integer_T self) -> std::vector< int >::reverse_iterator"},
+	 { "vector_integer_T_rend", _wrap_vector_integer_T_rend, METH_O, "vector_integer_T_rend(vector_integer_T self) -> std::vector< int >::reverse_iterator"},
+	 { "vector_integer_T_clear", _wrap_vector_integer_T_clear, METH_O, "vector_integer_T_clear(vector_integer_T self)"},
+	 { "vector_integer_T_get_allocator", _wrap_vector_integer_T_get_allocator, METH_O, "vector_integer_T_get_allocator(vector_integer_T self) -> std::vector< int >::allocator_type"},
+	 { "vector_integer_T_pop_back", _wrap_vector_integer_T_pop_back, METH_O, "vector_integer_T_pop_back(vector_integer_T self)"},
+	 { "vector_integer_T_erase", _wrap_vector_integer_T_erase, METH_VARARGS, "\n"
+		"vector_integer_T_erase(vector_integer_T self, std::vector< int >::iterator pos) -> std::vector< int >::iterator\n"
+		"vector_integer_T_erase(vector_integer_T self, std::vector< int >::iterator first, std::vector< int >::iterator last) -> std::vector< int >::iterator\n"
 		""},
-	 { "new_vector_integer_t", _wrap_new_vector_integer_t, METH_VARARGS, "\n"
-		"vector_integer_t()\n"
-		"vector_integer_t(vector_integer_t other)\n"
-		"vector_integer_t(std::vector< int >::size_type size)\n"
-		"new_vector_integer_t(std::vector< int >::size_type size, std::vector< int >::value_type const & value) -> vector_integer_t\n"
+	 { "new_vector_integer_T", _wrap_new_vector_integer_T, METH_VARARGS, "\n"
+		"vector_integer_T()\n"
+		"vector_integer_T(vector_integer_T other)\n"
+		"vector_integer_T(std::vector< int >::size_type size)\n"
+		"new_vector_integer_T(std::vector< int >::size_type size, std::vector< int >::value_type const & value) -> vector_integer_T\n"
 		""},
-	 { "vector_integer_t_push_back", _wrap_vector_integer_t_push_back, METH_VARARGS, "vector_integer_t_push_back(vector_integer_t self, std::vector< int >::value_type const & x)"},
-	 { "vector_integer_t_front", _wrap_vector_integer_t_front, METH_O, "vector_integer_t_front(vector_integer_t self) -> std::vector< int >::value_type const &"},
-	 { "vector_integer_t_back", _wrap_vector_integer_t_back, METH_O, "vector_integer_t_back(vector_integer_t self) -> std::vector< int >::value_type const &"},
-	 { "vector_integer_t_assign", _wrap_vector_integer_t_assign, METH_VARARGS, "vector_integer_t_assign(vector_integer_t self, std::vector< int >::size_type n, std::vector< int >::value_type const & x)"},
-	 { "vector_integer_t_resize", _wrap_vector_integer_t_resize, METH_VARARGS, "\n"
-		"vector_integer_t_resize(vector_integer_t self, std::vector< int >::size_type new_size)\n"
-		"vector_integer_t_resize(vector_integer_t self, std::vector< int >::size_type new_size, std::vector< int >::value_type const & x)\n"
+	 { "vector_integer_T_push_back", _wrap_vector_integer_T_push_back, METH_VARARGS, "vector_integer_T_push_back(vector_integer_T self, std::vector< int >::value_type const & x)"},
+	 { "vector_integer_T_front", _wrap_vector_integer_T_front, METH_O, "vector_integer_T_front(vector_integer_T self) -> std::vector< int >::value_type const &"},
+	 { "vector_integer_T_back", _wrap_vector_integer_T_back, METH_O, "vector_integer_T_back(vector_integer_T self) -> std::vector< int >::value_type const &"},
+	 { "vector_integer_T_assign", _wrap_vector_integer_T_assign, METH_VARARGS, "vector_integer_T_assign(vector_integer_T self, std::vector< int >::size_type n, std::vector< int >::value_type const & x)"},
+	 { "vector_integer_T_resize", _wrap_vector_integer_T_resize, METH_VARARGS, "\n"
+		"vector_integer_T_resize(vector_integer_T self, std::vector< int >::size_type new_size)\n"
+		"vector_integer_T_resize(vector_integer_T self, std::vector< int >::size_type new_size, std::vector< int >::value_type const & x)\n"
 		""},
-	 { "vector_integer_t_insert", _wrap_vector_integer_t_insert, METH_VARARGS, "\n"
-		"vector_integer_t_insert(vector_integer_t self, std::vector< int >::iterator pos, std::vector< int >::value_type const & x) -> std::vector< int >::iterator\n"
-		"vector_integer_t_insert(vector_integer_t self, std::vector< int >::iterator pos, std::vector< int >::size_type n, std::vector< int >::value_type const & x)\n"
+	 { "vector_integer_T_insert", _wrap_vector_integer_T_insert, METH_VARARGS, "\n"
+		"vector_integer_T_insert(vector_integer_T self, std::vector< int >::iterator pos, std::vector< int >::value_type const & x) -> std::vector< int >::iterator\n"
+		"vector_integer_T_insert(vector_integer_T self, std::vector< int >::iterator pos, std::vector< int >::size_type n, std::vector< int >::value_type const & x)\n"
 		""},
-	 { "vector_integer_t_reserve", _wrap_vector_integer_t_reserve, METH_VARARGS, "vector_integer_t_reserve(vector_integer_t self, std::vector< int >::size_type n)"},
-	 { "vector_integer_t_capacity", _wrap_vector_integer_t_capacity, METH_O, "vector_integer_t_capacity(vector_integer_t self) -> std::vector< int >::size_type"},
-	 { "delete_vector_integer_t", _wrap_delete_vector_integer_t, METH_O, "delete_vector_integer_t(vector_integer_t self)"},
-	 { "vector_integer_t_swigregister", vector_integer_t_swigregister, METH_O, NULL},
-	 { "vector_integer_t_swiginit", vector_integer_t_swiginit, METH_VARARGS, NULL},
-	 { "vinteger2d_t_iterator", _wrap_vinteger2d_t_iterator, METH_O, "vinteger2d_t_iterator(vinteger2d_t self) -> SwigPyIterator"},
-	 { "vinteger2d_t___nonzero__", _wrap_vinteger2d_t___nonzero__, METH_O, "vinteger2d_t___nonzero__(vinteger2d_t self) -> bool"},
-	 { "vinteger2d_t___bool__", _wrap_vinteger2d_t___bool__, METH_O, "vinteger2d_t___bool__(vinteger2d_t self) -> bool"},
-	 { "vinteger2d_t___len__", _wrap_vinteger2d_t___len__, METH_O, "vinteger2d_t___len__(vinteger2d_t self) -> std::vector< std::vector< int > >::size_type"},
-	 { "vinteger2d_t___getslice__", _wrap_vinteger2d_t___getslice__, METH_VARARGS, "vinteger2d_t___getslice__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j) -> vinteger2d_t"},
-	 { "vinteger2d_t___setslice__", _wrap_vinteger2d_t___setslice__, METH_VARARGS, "\n"
-		"vinteger2d_t___setslice__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j)\n"
-		"vinteger2d_t___setslice__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j, vinteger2d_t v)\n"
+	 { "vector_integer_T_reserve", _wrap_vector_integer_T_reserve, METH_VARARGS, "vector_integer_T_reserve(vector_integer_T self, std::vector< int >::size_type n)"},
+	 { "vector_integer_T_capacity", _wrap_vector_integer_T_capacity, METH_O, "vector_integer_T_capacity(vector_integer_T self) -> std::vector< int >::size_type"},
+	 { "delete_vector_integer_T", _wrap_delete_vector_integer_T, METH_O, "delete_vector_integer_T(vector_integer_T self)"},
+	 { "vector_integer_T_swigregister", vector_integer_T_swigregister, METH_O, NULL},
+	 { "vector_integer_T_swiginit", vector_integer_T_swiginit, METH_VARARGS, NULL},
+	 { "vinteger2d_T_iterator", _wrap_vinteger2d_T_iterator, METH_O, "vinteger2d_T_iterator(vinteger2d_T self) -> SwigPyIterator"},
+	 { "vinteger2d_T___nonzero__", _wrap_vinteger2d_T___nonzero__, METH_O, "vinteger2d_T___nonzero__(vinteger2d_T self) -> bool"},
+	 { "vinteger2d_T___bool__", _wrap_vinteger2d_T___bool__, METH_O, "vinteger2d_T___bool__(vinteger2d_T self) -> bool"},
+	 { "vinteger2d_T___len__", _wrap_vinteger2d_T___len__, METH_O, "vinteger2d_T___len__(vinteger2d_T self) -> std::vector< std::vector< int > >::size_type"},
+	 { "vinteger2d_T___getslice__", _wrap_vinteger2d_T___getslice__, METH_VARARGS, "vinteger2d_T___getslice__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j) -> vinteger2d_T"},
+	 { "vinteger2d_T___setslice__", _wrap_vinteger2d_T___setslice__, METH_VARARGS, "\n"
+		"vinteger2d_T___setslice__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j)\n"
+		"vinteger2d_T___setslice__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j, vinteger2d_T v)\n"
 		""},
-	 { "vinteger2d_t___delslice__", _wrap_vinteger2d_t___delslice__, METH_VARARGS, "vinteger2d_t___delslice__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j)"},
-	 { "vinteger2d_t___delitem__", _wrap_vinteger2d_t___delitem__, METH_VARARGS, "\n"
-		"vinteger2d_t___delitem__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i)\n"
-		"vinteger2d_t___delitem__(vinteger2d_t self, SWIGPY_SLICEOBJECT * slice)\n"
+	 { "vinteger2d_T___delslice__", _wrap_vinteger2d_T___delslice__, METH_VARARGS, "vinteger2d_T___delslice__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i, std::vector< std::vector< int > >::difference_type j)"},
+	 { "vinteger2d_T___delitem__", _wrap_vinteger2d_T___delitem__, METH_VARARGS, "\n"
+		"vinteger2d_T___delitem__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i)\n"
+		"vinteger2d_T___delitem__(vinteger2d_T self, SWIGPY_SLICEOBJECT * slice)\n"
 		""},
-	 { "vinteger2d_t___getitem__", _wrap_vinteger2d_t___getitem__, METH_VARARGS, "\n"
-		"vinteger2d_t___getitem__(vinteger2d_t self, SWIGPY_SLICEOBJECT * slice) -> vinteger2d_t\n"
-		"vinteger2d_t___getitem__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i) -> vector_integer_t\n"
+	 { "vinteger2d_T___getitem__", _wrap_vinteger2d_T___getitem__, METH_VARARGS, "\n"
+		"vinteger2d_T___getitem__(vinteger2d_T self, SWIGPY_SLICEOBJECT * slice) -> vinteger2d_T\n"
+		"vinteger2d_T___getitem__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i) -> vector_integer_T\n"
 		""},
-	 { "vinteger2d_t___setitem__", _wrap_vinteger2d_t___setitem__, METH_VARARGS, "\n"
-		"vinteger2d_t___setitem__(vinteger2d_t self, SWIGPY_SLICEOBJECT * slice, vinteger2d_t v)\n"
-		"vinteger2d_t___setitem__(vinteger2d_t self, SWIGPY_SLICEOBJECT * slice)\n"
-		"vinteger2d_t___setitem__(vinteger2d_t self, std::vector< std::vector< int > >::difference_type i, vector_integer_t x)\n"
+	 { "vinteger2d_T___setitem__", _wrap_vinteger2d_T___setitem__, METH_VARARGS, "\n"
+		"vinteger2d_T___setitem__(vinteger2d_T self, SWIGPY_SLICEOBJECT * slice, vinteger2d_T v)\n"
+		"vinteger2d_T___setitem__(vinteger2d_T self, SWIGPY_SLICEOBJECT * slice)\n"
+		"vinteger2d_T___setitem__(vinteger2d_T self, std::vector< std::vector< int > >::difference_type i, vector_integer_T x)\n"
 		""},
-	 { "vinteger2d_t_pop", _wrap_vinteger2d_t_pop, METH_O, "vinteger2d_t_pop(vinteger2d_t self) -> vector_integer_t"},
-	 { "vinteger2d_t_append", _wrap_vinteger2d_t_append, METH_VARARGS, "vinteger2d_t_append(vinteger2d_t self, vector_integer_t x)"},
-	 { "vinteger2d_t_empty", _wrap_vinteger2d_t_empty, METH_O, "vinteger2d_t_empty(vinteger2d_t self) -> bool"},
-	 { "vinteger2d_t_size", _wrap_vinteger2d_t_size, METH_O, "vinteger2d_t_size(vinteger2d_t self) -> std::vector< std::vector< int > >::size_type"},
-	 { "vinteger2d_t_swap", _wrap_vinteger2d_t_swap, METH_VARARGS, "vinteger2d_t_swap(vinteger2d_t self, vinteger2d_t v)"},
-	 { "vinteger2d_t_begin", _wrap_vinteger2d_t_begin, METH_O, "vinteger2d_t_begin(vinteger2d_t self) -> std::vector< std::vector< int > >::iterator"},
-	 { "vinteger2d_t_end", _wrap_vinteger2d_t_end, METH_O, "vinteger2d_t_end(vinteger2d_t self) -> std::vector< std::vector< int > >::iterator"},
-	 { "vinteger2d_t_rbegin", _wrap_vinteger2d_t_rbegin, METH_O, "vinteger2d_t_rbegin(vinteger2d_t self) -> std::vector< std::vector< int > >::reverse_iterator"},
-	 { "vinteger2d_t_rend", _wrap_vinteger2d_t_rend, METH_O, "vinteger2d_t_rend(vinteger2d_t self) -> std::vector< std::vector< int > >::reverse_iterator"},
-	 { "vinteger2d_t_clear", _wrap_vinteger2d_t_clear, METH_O, "vinteger2d_t_clear(vinteger2d_t self)"},
-	 { "vinteger2d_t_get_allocator", _wrap_vinteger2d_t_get_allocator, METH_O, "vinteger2d_t_get_allocator(vinteger2d_t self) -> std::vector< std::vector< int > >::allocator_type"},
-	 { "vinteger2d_t_pop_back", _wrap_vinteger2d_t_pop_back, METH_O, "vinteger2d_t_pop_back(vinteger2d_t self)"},
-	 { "vinteger2d_t_erase", _wrap_vinteger2d_t_erase, METH_VARARGS, "\n"
-		"vinteger2d_t_erase(vinteger2d_t self, std::vector< std::vector< int > >::iterator pos) -> std::vector< std::vector< int > >::iterator\n"
-		"vinteger2d_t_erase(vinteger2d_t self, std::vector< std::vector< int > >::iterator first, std::vector< std::vector< int > >::iterator last) -> std::vector< std::vector< int > >::iterator\n"
+	 { "vinteger2d_T_pop", _wrap_vinteger2d_T_pop, METH_O, "vinteger2d_T_pop(vinteger2d_T self) -> vector_integer_T"},
+	 { "vinteger2d_T_append", _wrap_vinteger2d_T_append, METH_VARARGS, "vinteger2d_T_append(vinteger2d_T self, vector_integer_T x)"},
+	 { "vinteger2d_T_empty", _wrap_vinteger2d_T_empty, METH_O, "vinteger2d_T_empty(vinteger2d_T self) -> bool"},
+	 { "vinteger2d_T_size", _wrap_vinteger2d_T_size, METH_O, "vinteger2d_T_size(vinteger2d_T self) -> std::vector< std::vector< int > >::size_type"},
+	 { "vinteger2d_T_swap", _wrap_vinteger2d_T_swap, METH_VARARGS, "vinteger2d_T_swap(vinteger2d_T self, vinteger2d_T v)"},
+	 { "vinteger2d_T_begin", _wrap_vinteger2d_T_begin, METH_O, "vinteger2d_T_begin(vinteger2d_T self) -> std::vector< std::vector< int > >::iterator"},
+	 { "vinteger2d_T_end", _wrap_vinteger2d_T_end, METH_O, "vinteger2d_T_end(vinteger2d_T self) -> std::vector< std::vector< int > >::iterator"},
+	 { "vinteger2d_T_rbegin", _wrap_vinteger2d_T_rbegin, METH_O, "vinteger2d_T_rbegin(vinteger2d_T self) -> std::vector< std::vector< int > >::reverse_iterator"},
+	 { "vinteger2d_T_rend", _wrap_vinteger2d_T_rend, METH_O, "vinteger2d_T_rend(vinteger2d_T self) -> std::vector< std::vector< int > >::reverse_iterator"},
+	 { "vinteger2d_T_clear", _wrap_vinteger2d_T_clear, METH_O, "vinteger2d_T_clear(vinteger2d_T self)"},
+	 { "vinteger2d_T_get_allocator", _wrap_vinteger2d_T_get_allocator, METH_O, "vinteger2d_T_get_allocator(vinteger2d_T self) -> std::vector< std::vector< int > >::allocator_type"},
+	 { "vinteger2d_T_pop_back", _wrap_vinteger2d_T_pop_back, METH_O, "vinteger2d_T_pop_back(vinteger2d_T self)"},
+	 { "vinteger2d_T_erase", _wrap_vinteger2d_T_erase, METH_VARARGS, "\n"
+		"vinteger2d_T_erase(vinteger2d_T self, std::vector< std::vector< int > >::iterator pos) -> std::vector< std::vector< int > >::iterator\n"
+		"vinteger2d_T_erase(vinteger2d_T self, std::vector< std::vector< int > >::iterator first, std::vector< std::vector< int > >::iterator last) -> std::vector< std::vector< int > >::iterator\n"
 		""},
-	 { "new_vinteger2d_t", _wrap_new_vinteger2d_t, METH_VARARGS, "\n"
-		"vinteger2d_t()\n"
-		"vinteger2d_t(vinteger2d_t other)\n"
-		"vinteger2d_t(std::vector< std::vector< int > >::size_type size)\n"
-		"new_vinteger2d_t(std::vector< std::vector< int > >::size_type size, vector_integer_t value) -> vinteger2d_t\n"
+	 { "new_vinteger2d_T", _wrap_new_vinteger2d_T, METH_VARARGS, "\n"
+		"vinteger2d_T()\n"
+		"vinteger2d_T(vinteger2d_T other)\n"
+		"vinteger2d_T(std::vector< std::vector< int > >::size_type size)\n"
+		"new_vinteger2d_T(std::vector< std::vector< int > >::size_type size, vector_integer_T value) -> vinteger2d_T\n"
 		""},
-	 { "vinteger2d_t_push_back", _wrap_vinteger2d_t_push_back, METH_VARARGS, "vinteger2d_t_push_back(vinteger2d_t self, vector_integer_t x)"},
-	 { "vinteger2d_t_front", _wrap_vinteger2d_t_front, METH_O, "vinteger2d_t_front(vinteger2d_t self) -> vector_integer_t"},
-	 { "vinteger2d_t_back", _wrap_vinteger2d_t_back, METH_O, "vinteger2d_t_back(vinteger2d_t self) -> vector_integer_t"},
-	 { "vinteger2d_t_assign", _wrap_vinteger2d_t_assign, METH_VARARGS, "vinteger2d_t_assign(vinteger2d_t self, std::vector< std::vector< int > >::size_type n, vector_integer_t x)"},
-	 { "vinteger2d_t_resize", _wrap_vinteger2d_t_resize, METH_VARARGS, "\n"
-		"vinteger2d_t_resize(vinteger2d_t self, std::vector< std::vector< int > >::size_type new_size)\n"
-		"vinteger2d_t_resize(vinteger2d_t self, std::vector< std::vector< int > >::size_type new_size, vector_integer_t x)\n"
+	 { "vinteger2d_T_push_back", _wrap_vinteger2d_T_push_back, METH_VARARGS, "vinteger2d_T_push_back(vinteger2d_T self, vector_integer_T x)"},
+	 { "vinteger2d_T_front", _wrap_vinteger2d_T_front, METH_O, "vinteger2d_T_front(vinteger2d_T self) -> vector_integer_T"},
+	 { "vinteger2d_T_back", _wrap_vinteger2d_T_back, METH_O, "vinteger2d_T_back(vinteger2d_T self) -> vector_integer_T"},
+	 { "vinteger2d_T_assign", _wrap_vinteger2d_T_assign, METH_VARARGS, "vinteger2d_T_assign(vinteger2d_T self, std::vector< std::vector< int > >::size_type n, vector_integer_T x)"},
+	 { "vinteger2d_T_resize", _wrap_vinteger2d_T_resize, METH_VARARGS, "\n"
+		"vinteger2d_T_resize(vinteger2d_T self, std::vector< std::vector< int > >::size_type new_size)\n"
+		"vinteger2d_T_resize(vinteger2d_T self, std::vector< std::vector< int > >::size_type new_size, vector_integer_T x)\n"
 		""},
-	 { "vinteger2d_t_insert", _wrap_vinteger2d_t_insert, METH_VARARGS, "\n"
-		"vinteger2d_t_insert(vinteger2d_t self, std::vector< std::vector< int > >::iterator pos, vector_integer_t x) -> std::vector< std::vector< int > >::iterator\n"
-		"vinteger2d_t_insert(vinteger2d_t self, std::vector< std::vector< int > >::iterator pos, std::vector< std::vector< int > >::size_type n, vector_integer_t x)\n"
+	 { "vinteger2d_T_insert", _wrap_vinteger2d_T_insert, METH_VARARGS, "\n"
+		"vinteger2d_T_insert(vinteger2d_T self, std::vector< std::vector< int > >::iterator pos, vector_integer_T x) -> std::vector< std::vector< int > >::iterator\n"
+		"vinteger2d_T_insert(vinteger2d_T self, std::vector< std::vector< int > >::iterator pos, std::vector< std::vector< int > >::size_type n, vector_integer_T x)\n"
 		""},
-	 { "vinteger2d_t_reserve", _wrap_vinteger2d_t_reserve, METH_VARARGS, "vinteger2d_t_reserve(vinteger2d_t self, std::vector< std::vector< int > >::size_type n)"},
-	 { "vinteger2d_t_capacity", _wrap_vinteger2d_t_capacity, METH_O, "vinteger2d_t_capacity(vinteger2d_t self) -> std::vector< std::vector< int > >::size_type"},
-	 { "delete_vinteger2d_t", _wrap_delete_vinteger2d_t, METH_O, "delete_vinteger2d_t(vinteger2d_t self)"},
-	 { "vinteger2d_t_swigregister", vinteger2d_t_swigregister, METH_O, NULL},
-	 { "vinteger2d_t_swiginit", vinteger2d_t_swiginit, METH_VARARGS, NULL},
-	 { "vector_longinteger_t_iterator", _wrap_vector_longinteger_t_iterator, METH_O, "vector_longinteger_t_iterator(vector_longinteger_t self) -> SwigPyIterator"},
-	 { "vector_longinteger_t___nonzero__", _wrap_vector_longinteger_t___nonzero__, METH_O, "vector_longinteger_t___nonzero__(vector_longinteger_t self) -> bool"},
-	 { "vector_longinteger_t___bool__", _wrap_vector_longinteger_t___bool__, METH_O, "vector_longinteger_t___bool__(vector_longinteger_t self) -> bool"},
-	 { "vector_longinteger_t___len__", _wrap_vector_longinteger_t___len__, METH_O, "vector_longinteger_t___len__(vector_longinteger_t self) -> std::vector< unsigned long >::size_type"},
-	 { "vector_longinteger_t___getslice__", _wrap_vector_longinteger_t___getslice__, METH_VARARGS, "vector_longinteger_t___getslice__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j) -> vector_longinteger_t"},
-	 { "vector_longinteger_t___setslice__", _wrap_vector_longinteger_t___setslice__, METH_VARARGS, "\n"
-		"vector_longinteger_t___setslice__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j)\n"
-		"vector_longinteger_t___setslice__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j, vector_longinteger_t v)\n"
+	 { "vinteger2d_T_reserve", _wrap_vinteger2d_T_reserve, METH_VARARGS, "vinteger2d_T_reserve(vinteger2d_T self, std::vector< std::vector< int > >::size_type n)"},
+	 { "vinteger2d_T_capacity", _wrap_vinteger2d_T_capacity, METH_O, "vinteger2d_T_capacity(vinteger2d_T self) -> std::vector< std::vector< int > >::size_type"},
+	 { "delete_vinteger2d_T", _wrap_delete_vinteger2d_T, METH_O, "delete_vinteger2d_T(vinteger2d_T self)"},
+	 { "vinteger2d_T_swigregister", vinteger2d_T_swigregister, METH_O, NULL},
+	 { "vinteger2d_T_swiginit", vinteger2d_T_swiginit, METH_VARARGS, NULL},
+	 { "vector_longinteger_T_iterator", _wrap_vector_longinteger_T_iterator, METH_O, "vector_longinteger_T_iterator(vector_longinteger_T self) -> SwigPyIterator"},
+	 { "vector_longinteger_T___nonzero__", _wrap_vector_longinteger_T___nonzero__, METH_O, "vector_longinteger_T___nonzero__(vector_longinteger_T self) -> bool"},
+	 { "vector_longinteger_T___bool__", _wrap_vector_longinteger_T___bool__, METH_O, "vector_longinteger_T___bool__(vector_longinteger_T self) -> bool"},
+	 { "vector_longinteger_T___len__", _wrap_vector_longinteger_T___len__, METH_O, "vector_longinteger_T___len__(vector_longinteger_T self) -> std::vector< unsigned long >::size_type"},
+	 { "vector_longinteger_T___getslice__", _wrap_vector_longinteger_T___getslice__, METH_VARARGS, "vector_longinteger_T___getslice__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j) -> vector_longinteger_T"},
+	 { "vector_longinteger_T___setslice__", _wrap_vector_longinteger_T___setslice__, METH_VARARGS, "\n"
+		"vector_longinteger_T___setslice__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j)\n"
+		"vector_longinteger_T___setslice__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j, vector_longinteger_T v)\n"
 		""},
-	 { "vector_longinteger_t___delslice__", _wrap_vector_longinteger_t___delslice__, METH_VARARGS, "vector_longinteger_t___delslice__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j)"},
-	 { "vector_longinteger_t___delitem__", _wrap_vector_longinteger_t___delitem__, METH_VARARGS, "\n"
-		"vector_longinteger_t___delitem__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i)\n"
-		"vector_longinteger_t___delitem__(vector_longinteger_t self, SWIGPY_SLICEOBJECT * slice)\n"
+	 { "vector_longinteger_T___delslice__", _wrap_vector_longinteger_T___delslice__, METH_VARARGS, "vector_longinteger_T___delslice__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::difference_type j)"},
+	 { "vector_longinteger_T___delitem__", _wrap_vector_longinteger_T___delitem__, METH_VARARGS, "\n"
+		"vector_longinteger_T___delitem__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i)\n"
+		"vector_longinteger_T___delitem__(vector_longinteger_T self, SWIGPY_SLICEOBJECT * slice)\n"
 		""},
-	 { "vector_longinteger_t___getitem__", _wrap_vector_longinteger_t___getitem__, METH_VARARGS, "\n"
-		"vector_longinteger_t___getitem__(vector_longinteger_t self, SWIGPY_SLICEOBJECT * slice) -> vector_longinteger_t\n"
-		"vector_longinteger_t___getitem__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i) -> std::vector< unsigned long >::value_type const &\n"
+	 { "vector_longinteger_T___getitem__", _wrap_vector_longinteger_T___getitem__, METH_VARARGS, "\n"
+		"vector_longinteger_T___getitem__(vector_longinteger_T self, SWIGPY_SLICEOBJECT * slice) -> vector_longinteger_T\n"
+		"vector_longinteger_T___getitem__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i) -> std::vector< unsigned long >::value_type const &\n"
 		""},
-	 { "vector_longinteger_t___setitem__", _wrap_vector_longinteger_t___setitem__, METH_VARARGS, "\n"
-		"vector_longinteger_t___setitem__(vector_longinteger_t self, SWIGPY_SLICEOBJECT * slice, vector_longinteger_t v)\n"
-		"vector_longinteger_t___setitem__(vector_longinteger_t self, SWIGPY_SLICEOBJECT * slice)\n"
-		"vector_longinteger_t___setitem__(vector_longinteger_t self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::value_type const & x)\n"
+	 { "vector_longinteger_T___setitem__", _wrap_vector_longinteger_T___setitem__, METH_VARARGS, "\n"
+		"vector_longinteger_T___setitem__(vector_longinteger_T self, SWIGPY_SLICEOBJECT * slice, vector_longinteger_T v)\n"
+		"vector_longinteger_T___setitem__(vector_longinteger_T self, SWIGPY_SLICEOBJECT * slice)\n"
+		"vector_longinteger_T___setitem__(vector_longinteger_T self, std::vector< unsigned long >::difference_type i, std::vector< unsigned long >::value_type const & x)\n"
 		""},
-	 { "vector_longinteger_t_pop", _wrap_vector_longinteger_t_pop, METH_O, "vector_longinteger_t_pop(vector_longinteger_t self) -> std::vector< unsigned long >::value_type"},
-	 { "vector_longinteger_t_append", _wrap_vector_longinteger_t_append, METH_VARARGS, "vector_longinteger_t_append(vector_longinteger_t self, std::vector< unsigned long >::value_type const & x)"},
-	 { "vector_longinteger_t_empty", _wrap_vector_longinteger_t_empty, METH_O, "vector_longinteger_t_empty(vector_longinteger_t self) -> bool"},
-	 { "vector_longinteger_t_size", _wrap_vector_longinteger_t_size, METH_O, "vector_longinteger_t_size(vector_longinteger_t self) -> std::vector< unsigned long >::size_type"},
-	 { "vector_longinteger_t_swap", _wrap_vector_longinteger_t_swap, METH_VARARGS, "vector_longinteger_t_swap(vector_longinteger_t self, vector_longinteger_t v)"},
-	 { "vector_longinteger_t_begin", _wrap_vector_longinteger_t_begin, METH_O, "vector_longinteger_t_begin(vector_longinteger_t self) -> std::vector< unsigned long >::iterator"},
-	 { "vector_longinteger_t_end", _wrap_vector_longinteger_t_end, METH_O, "vector_longinteger_t_end(vector_longinteger_t self) -> std::vector< unsigned long >::iterator"},
-	 { "vector_longinteger_t_rbegin", _wrap_vector_longinteger_t_rbegin, METH_O, "vector_longinteger_t_rbegin(vector_longinteger_t self) -> std::vector< unsigned long >::reverse_iterator"},
-	 { "vector_longinteger_t_rend", _wrap_vector_longinteger_t_rend, METH_O, "vector_longinteger_t_rend(vector_longinteger_t self) -> std::vector< unsigned long >::reverse_iterator"},
-	 { "vector_longinteger_t_clear", _wrap_vector_longinteger_t_clear, METH_O, "vector_longinteger_t_clear(vector_longinteger_t self)"},
-	 { "vector_longinteger_t_get_allocator", _wrap_vector_longinteger_t_get_allocator, METH_O, "vector_longinteger_t_get_allocator(vector_longinteger_t self) -> std::vector< unsigned long >::allocator_type"},
-	 { "vector_longinteger_t_pop_back", _wrap_vector_longinteger_t_pop_back, METH_O, "vector_longinteger_t_pop_back(vector_longinteger_t self)"},
-	 { "vector_longinteger_t_erase", _wrap_vector_longinteger_t_erase, METH_VARARGS, "\n"
-		"vector_longinteger_t_erase(vector_longinteger_t self, std::vector< unsigned long >::iterator pos) -> std::vector< unsigned long >::iterator\n"
-		"vector_longinteger_t_erase(vector_longinteger_t self, std::vector< unsigned long >::iterator first, std::vector< unsigned long >::iterator last) -> std::vector< unsigned long >::iterator\n"
+	 { "vector_longinteger_T_pop", _wrap_vector_longinteger_T_pop, METH_O, "vector_longinteger_T_pop(vector_longinteger_T self) -> std::vector< unsigned long >::value_type"},
+	 { "vector_longinteger_T_append", _wrap_vector_longinteger_T_append, METH_VARARGS, "vector_longinteger_T_append(vector_longinteger_T self, std::vector< unsigned long >::value_type const & x)"},
+	 { "vector_longinteger_T_empty", _wrap_vector_longinteger_T_empty, METH_O, "vector_longinteger_T_empty(vector_longinteger_T self) -> bool"},
+	 { "vector_longinteger_T_size", _wrap_vector_longinteger_T_size, METH_O, "vector_longinteger_T_size(vector_longinteger_T self) -> std::vector< unsigned long >::size_type"},
+	 { "vector_longinteger_T_swap", _wrap_vector_longinteger_T_swap, METH_VARARGS, "vector_longinteger_T_swap(vector_longinteger_T self, vector_longinteger_T v)"},
+	 { "vector_longinteger_T_begin", _wrap_vector_longinteger_T_begin, METH_O, "vector_longinteger_T_begin(vector_longinteger_T self) -> std::vector< unsigned long >::iterator"},
+	 { "vector_longinteger_T_end", _wrap_vector_longinteger_T_end, METH_O, "vector_longinteger_T_end(vector_longinteger_T self) -> std::vector< unsigned long >::iterator"},
+	 { "vector_longinteger_T_rbegin", _wrap_vector_longinteger_T_rbegin, METH_O, "vector_longinteger_T_rbegin(vector_longinteger_T self) -> std::vector< unsigned long >::reverse_iterator"},
+	 { "vector_longinteger_T_rend", _wrap_vector_longinteger_T_rend, METH_O, "vector_longinteger_T_rend(vector_longinteger_T self) -> std::vector< unsigned long >::reverse_iterator"},
+	 { "vector_longinteger_T_clear", _wrap_vector_longinteger_T_clear, METH_O, "vector_longinteger_T_clear(vector_longinteger_T self)"},
+	 { "vector_longinteger_T_get_allocator", _wrap_vector_longinteger_T_get_allocator, METH_O, "vector_longinteger_T_get_allocator(vector_longinteger_T self) -> std::vector< unsigned long >::allocator_type"},
+	 { "vector_longinteger_T_pop_back", _wrap_vector_longinteger_T_pop_back, METH_O, "vector_longinteger_T_pop_back(vector_longinteger_T self)"},
+	 { "vector_longinteger_T_erase", _wrap_vector_longinteger_T_erase, METH_VARARGS, "\n"
+		"vector_longinteger_T_erase(vector_longinteger_T self, std::vector< unsigned long >::iterator pos) -> std::vector< unsigned long >::iterator\n"
+		"vector_longinteger_T_erase(vector_longinteger_T self, std::vector< unsigned long >::iterator first, std::vector< unsigned long >::iterator last) -> std::vector< unsigned long >::iterator\n"
 		""},
-	 { "new_vector_longinteger_t", _wrap_new_vector_longinteger_t, METH_VARARGS, "\n"
-		"vector_longinteger_t()\n"
-		"vector_longinteger_t(vector_longinteger_t other)\n"
-		"vector_longinteger_t(std::vector< unsigned long >::size_type size)\n"
-		"new_vector_longinteger_t(std::vector< unsigned long >::size_type size, std::vector< unsigned long >::value_type const & value) -> vector_longinteger_t\n"
+	 { "new_vector_longinteger_T", _wrap_new_vector_longinteger_T, METH_VARARGS, "\n"
+		"vector_longinteger_T()\n"
+		"vector_longinteger_T(vector_longinteger_T other)\n"
+		"vector_longinteger_T(std::vector< unsigned long >::size_type size)\n"
+		"new_vector_longinteger_T(std::vector< unsigned long >::size_type size, std::vector< unsigned long >::value_type const & value) -> vector_longinteger_T\n"
 		""},
-	 { "vector_longinteger_t_push_back", _wrap_vector_longinteger_t_push_back, METH_VARARGS, "vector_longinteger_t_push_back(vector_longinteger_t self, std::vector< unsigned long >::value_type const & x)"},
-	 { "vector_longinteger_t_front", _wrap_vector_longinteger_t_front, METH_O, "vector_longinteger_t_front(vector_longinteger_t self) -> std::vector< unsigned long >::value_type const &"},
-	 { "vector_longinteger_t_back", _wrap_vector_longinteger_t_back, METH_O, "vector_longinteger_t_back(vector_longinteger_t self) -> std::vector< unsigned long >::value_type const &"},
-	 { "vector_longinteger_t_assign", _wrap_vector_longinteger_t_assign, METH_VARARGS, "vector_longinteger_t_assign(vector_longinteger_t self, std::vector< unsigned long >::size_type n, std::vector< unsigned long >::value_type const & x)"},
-	 { "vector_longinteger_t_resize", _wrap_vector_longinteger_t_resize, METH_VARARGS, "\n"
-		"vector_longinteger_t_resize(vector_longinteger_t self, std::vector< unsigned long >::size_type new_size)\n"
-		"vector_longinteger_t_resize(vector_longinteger_t self, std::vector< unsigned long >::size_type new_size, std::vector< unsigned long >::value_type const & x)\n"
+	 { "vector_longinteger_T_push_back", _wrap_vector_longinteger_T_push_back, METH_VARARGS, "vector_longinteger_T_push_back(vector_longinteger_T self, std::vector< unsigned long >::value_type const & x)"},
+	 { "vector_longinteger_T_front", _wrap_vector_longinteger_T_front, METH_O, "vector_longinteger_T_front(vector_longinteger_T self) -> std::vector< unsigned long >::value_type const &"},
+	 { "vector_longinteger_T_back", _wrap_vector_longinteger_T_back, METH_O, "vector_longinteger_T_back(vector_longinteger_T self) -> std::vector< unsigned long >::value_type const &"},
+	 { "vector_longinteger_T_assign", _wrap_vector_longinteger_T_assign, METH_VARARGS, "vector_longinteger_T_assign(vector_longinteger_T self, std::vector< unsigned long >::size_type n, std::vector< unsigned long >::value_type const & x)"},
+	 { "vector_longinteger_T_resize", _wrap_vector_longinteger_T_resize, METH_VARARGS, "\n"
+		"vector_longinteger_T_resize(vector_longinteger_T self, std::vector< unsigned long >::size_type new_size)\n"
+		"vector_longinteger_T_resize(vector_longinteger_T self, std::vector< unsigned long >::size_type new_size, std::vector< unsigned long >::value_type const & x)\n"
 		""},
-	 { "vector_longinteger_t_insert", _wrap_vector_longinteger_t_insert, METH_VARARGS, "\n"
-		"vector_longinteger_t_insert(vector_longinteger_t self, std::vector< unsigned long >::iterator pos, std::vector< unsigned long >::value_type const & x) -> std::vector< unsigned long >::iterator\n"
-		"vector_longinteger_t_insert(vector_longinteger_t self, std::vector< unsigned long >::iterator pos, std::vector< unsigned long >::size_type n, std::vector< unsigned long >::value_type const & x)\n"
+	 { "vector_longinteger_T_insert", _wrap_vector_longinteger_T_insert, METH_VARARGS, "\n"
+		"vector_longinteger_T_insert(vector_longinteger_T self, std::vector< unsigned long >::iterator pos, std::vector< unsigned long >::value_type const & x) -> std::vector< unsigned long >::iterator\n"
+		"vector_longinteger_T_insert(vector_longinteger_T self, std::vector< unsigned long >::iterator pos, std::vector< unsigned long >::size_type n, std::vector< unsigned long >::value_type const & x)\n"
 		""},
-	 { "vector_longinteger_t_reserve", _wrap_vector_longinteger_t_reserve, METH_VARARGS, "vector_longinteger_t_reserve(vector_longinteger_t self, std::vector< unsigned long >::size_type n)"},
-	 { "vector_longinteger_t_capacity", _wrap_vector_longinteger_t_capacity, METH_O, "vector_longinteger_t_capacity(vector_longinteger_t self) -> std::vector< unsigned long >::size_type"},
-	 { "delete_vector_longinteger_t", _wrap_delete_vector_longinteger_t, METH_O, "delete_vector_longinteger_t(vector_longinteger_t self)"},
-	 { "vector_longinteger_t_swigregister", vector_longinteger_t_swigregister, METH_O, NULL},
-	 { "vector_longinteger_t_swiginit", vector_longinteger_t_swiginit, METH_VARARGS, NULL},
-	 { "vector_complex_t_iterator", _wrap_vector_complex_t_iterator, METH_O, "vector_complex_t_iterator(vector_complex_t self) -> SwigPyIterator"},
-	 { "vector_complex_t___nonzero__", _wrap_vector_complex_t___nonzero__, METH_O, "vector_complex_t___nonzero__(vector_complex_t self) -> bool"},
-	 { "vector_complex_t___bool__", _wrap_vector_complex_t___bool__, METH_O, "vector_complex_t___bool__(vector_complex_t self) -> bool"},
-	 { "vector_complex_t___len__", _wrap_vector_complex_t___len__, METH_O, "vector_complex_t___len__(vector_complex_t self) -> std::vector< std::complex< double > >::size_type"},
-	 { "vector_complex_t___getslice__", _wrap_vector_complex_t___getslice__, METH_VARARGS, "vector_complex_t___getslice__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j) -> vector_complex_t"},
-	 { "vector_complex_t___setslice__", _wrap_vector_complex_t___setslice__, METH_VARARGS, "\n"
-		"vector_complex_t___setslice__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j)\n"
-		"vector_complex_t___setslice__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j, vector_complex_t v)\n"
+	 { "vector_longinteger_T_reserve", _wrap_vector_longinteger_T_reserve, METH_VARARGS, "vector_longinteger_T_reserve(vector_longinteger_T self, std::vector< unsigned long >::size_type n)"},
+	 { "vector_longinteger_T_capacity", _wrap_vector_longinteger_T_capacity, METH_O, "vector_longinteger_T_capacity(vector_longinteger_T self) -> std::vector< unsigned long >::size_type"},
+	 { "delete_vector_longinteger_T", _wrap_delete_vector_longinteger_T, METH_O, "delete_vector_longinteger_T(vector_longinteger_T self)"},
+	 { "vector_longinteger_T_swigregister", vector_longinteger_T_swigregister, METH_O, NULL},
+	 { "vector_longinteger_T_swiginit", vector_longinteger_T_swiginit, METH_VARARGS, NULL},
+	 { "vector_complex_T_iterator", _wrap_vector_complex_T_iterator, METH_O, "vector_complex_T_iterator(vector_complex_T self) -> SwigPyIterator"},
+	 { "vector_complex_T___nonzero__", _wrap_vector_complex_T___nonzero__, METH_O, "vector_complex_T___nonzero__(vector_complex_T self) -> bool"},
+	 { "vector_complex_T___bool__", _wrap_vector_complex_T___bool__, METH_O, "vector_complex_T___bool__(vector_complex_T self) -> bool"},
+	 { "vector_complex_T___len__", _wrap_vector_complex_T___len__, METH_O, "vector_complex_T___len__(vector_complex_T self) -> std::vector< std::complex< double > >::size_type"},
+	 { "vector_complex_T___getslice__", _wrap_vector_complex_T___getslice__, METH_VARARGS, "vector_complex_T___getslice__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j) -> vector_complex_T"},
+	 { "vector_complex_T___setslice__", _wrap_vector_complex_T___setslice__, METH_VARARGS, "\n"
+		"vector_complex_T___setslice__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j)\n"
+		"vector_complex_T___setslice__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j, vector_complex_T v)\n"
 		""},
-	 { "vector_complex_t___delslice__", _wrap_vector_complex_t___delslice__, METH_VARARGS, "vector_complex_t___delslice__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j)"},
-	 { "vector_complex_t___delitem__", _wrap_vector_complex_t___delitem__, METH_VARARGS, "\n"
-		"vector_complex_t___delitem__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i)\n"
-		"vector_complex_t___delitem__(vector_complex_t self, SWIGPY_SLICEOBJECT * slice)\n"
+	 { "vector_complex_T___delslice__", _wrap_vector_complex_T___delslice__, METH_VARARGS, "vector_complex_T___delslice__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::difference_type j)"},
+	 { "vector_complex_T___delitem__", _wrap_vector_complex_T___delitem__, METH_VARARGS, "\n"
+		"vector_complex_T___delitem__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i)\n"
+		"vector_complex_T___delitem__(vector_complex_T self, SWIGPY_SLICEOBJECT * slice)\n"
 		""},
-	 { "vector_complex_t___getitem__", _wrap_vector_complex_t___getitem__, METH_VARARGS, "\n"
-		"vector_complex_t___getitem__(vector_complex_t self, SWIGPY_SLICEOBJECT * slice) -> vector_complex_t\n"
-		"vector_complex_t___getitem__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i) -> std::vector< std::complex< double > >::value_type const &\n"
+	 { "vector_complex_T___getitem__", _wrap_vector_complex_T___getitem__, METH_VARARGS, "\n"
+		"vector_complex_T___getitem__(vector_complex_T self, SWIGPY_SLICEOBJECT * slice) -> vector_complex_T\n"
+		"vector_complex_T___getitem__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i) -> std::vector< std::complex< double > >::value_type const &\n"
 		""},
-	 { "vector_complex_t___setitem__", _wrap_vector_complex_t___setitem__, METH_VARARGS, "\n"
-		"vector_complex_t___setitem__(vector_complex_t self, SWIGPY_SLICEOBJECT * slice, vector_complex_t v)\n"
-		"vector_complex_t___setitem__(vector_complex_t self, SWIGPY_SLICEOBJECT * slice)\n"
-		"vector_complex_t___setitem__(vector_complex_t self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::value_type const & x)\n"
+	 { "vector_complex_T___setitem__", _wrap_vector_complex_T___setitem__, METH_VARARGS, "\n"
+		"vector_complex_T___setitem__(vector_complex_T self, SWIGPY_SLICEOBJECT * slice, vector_complex_T v)\n"
+		"vector_complex_T___setitem__(vector_complex_T self, SWIGPY_SLICEOBJECT * slice)\n"
+		"vector_complex_T___setitem__(vector_complex_T self, std::vector< std::complex< double > >::difference_type i, std::vector< std::complex< double > >::value_type const & x)\n"
 		""},
-	 { "vector_complex_t_pop", _wrap_vector_complex_t_pop, METH_O, "vector_complex_t_pop(vector_complex_t self) -> std::vector< std::complex< double > >::value_type"},
-	 { "vector_complex_t_append", _wrap_vector_complex_t_append, METH_VARARGS, "vector_complex_t_append(vector_complex_t self, std::vector< std::complex< double > >::value_type const & x)"},
-	 { "vector_complex_t_empty", _wrap_vector_complex_t_empty, METH_O, "vector_complex_t_empty(vector_complex_t self) -> bool"},
-	 { "vector_complex_t_size", _wrap_vector_complex_t_size, METH_O, "vector_complex_t_size(vector_complex_t self) -> std::vector< std::complex< double > >::size_type"},
-	 { "vector_complex_t_swap", _wrap_vector_complex_t_swap, METH_VARARGS, "vector_complex_t_swap(vector_complex_t self, vector_complex_t v)"},
-	 { "vector_complex_t_begin", _wrap_vector_complex_t_begin, METH_O, "vector_complex_t_begin(vector_complex_t self) -> std::vector< std::complex< double > >::iterator"},
-	 { "vector_complex_t_end", _wrap_vector_complex_t_end, METH_O, "vector_complex_t_end(vector_complex_t self) -> std::vector< std::complex< double > >::iterator"},
-	 { "vector_complex_t_rbegin", _wrap_vector_complex_t_rbegin, METH_O, "vector_complex_t_rbegin(vector_complex_t self) -> std::vector< std::complex< double > >::reverse_iterator"},
-	 { "vector_complex_t_rend", _wrap_vector_complex_t_rend, METH_O, "vector_complex_t_rend(vector_complex_t self) -> std::vector< std::complex< double > >::reverse_iterator"},
-	 { "vector_complex_t_clear", _wrap_vector_complex_t_clear, METH_O, "vector_complex_t_clear(vector_complex_t self)"},
-	 { "vector_complex_t_get_allocator", _wrap_vector_complex_t_get_allocator, METH_O, "vector_complex_t_get_allocator(vector_complex_t self) -> std::vector< std::complex< double > >::allocator_type"},
-	 { "vector_complex_t_pop_back", _wrap_vector_complex_t_pop_back, METH_O, "vector_complex_t_pop_back(vector_complex_t self)"},
-	 { "vector_complex_t_erase", _wrap_vector_complex_t_erase, METH_VARARGS, "\n"
-		"vector_complex_t_erase(vector_complex_t self, std::vector< std::complex< double > >::iterator pos) -> std::vector< std::complex< double > >::iterator\n"
-		"vector_complex_t_erase(vector_complex_t self, std::vector< std::complex< double > >::iterator first, std::vector< std::complex< double > >::iterator last) -> std::vector< std::complex< double > >::iterator\n"
+	 { "vector_complex_T_pop", _wrap_vector_complex_T_pop, METH_O, "vector_complex_T_pop(vector_complex_T self) -> std::vector< std::complex< double > >::value_type"},
+	 { "vector_complex_T_append", _wrap_vector_complex_T_append, METH_VARARGS, "vector_complex_T_append(vector_complex_T self, std::vector< std::complex< double > >::value_type const & x)"},
+	 { "vector_complex_T_empty", _wrap_vector_complex_T_empty, METH_O, "vector_complex_T_empty(vector_complex_T self) -> bool"},
+	 { "vector_complex_T_size", _wrap_vector_complex_T_size, METH_O, "vector_complex_T_size(vector_complex_T self) -> std::vector< std::complex< double > >::size_type"},
+	 { "vector_complex_T_swap", _wrap_vector_complex_T_swap, METH_VARARGS, "vector_complex_T_swap(vector_complex_T self, vector_complex_T v)"},
+	 { "vector_complex_T_begin", _wrap_vector_complex_T_begin, METH_O, "vector_complex_T_begin(vector_complex_T self) -> std::vector< std::complex< double > >::iterator"},
+	 { "vector_complex_T_end", _wrap_vector_complex_T_end, METH_O, "vector_complex_T_end(vector_complex_T self) -> std::vector< std::complex< double > >::iterator"},
+	 { "vector_complex_T_rbegin", _wrap_vector_complex_T_rbegin, METH_O, "vector_complex_T_rbegin(vector_complex_T self) -> std::vector< std::complex< double > >::reverse_iterator"},
+	 { "vector_complex_T_rend", _wrap_vector_complex_T_rend, METH_O, "vector_complex_T_rend(vector_complex_T self) -> std::vector< std::complex< double > >::reverse_iterator"},
+	 { "vector_complex_T_clear", _wrap_vector_complex_T_clear, METH_O, "vector_complex_T_clear(vector_complex_T self)"},
+	 { "vector_complex_T_get_allocator", _wrap_vector_complex_T_get_allocator, METH_O, "vector_complex_T_get_allocator(vector_complex_T self) -> std::vector< std::complex< double > >::allocator_type"},
+	 { "vector_complex_T_pop_back", _wrap_vector_complex_T_pop_back, METH_O, "vector_complex_T_pop_back(vector_complex_T self)"},
+	 { "vector_complex_T_erase", _wrap_vector_complex_T_erase, METH_VARARGS, "\n"
+		"vector_complex_T_erase(vector_complex_T self, std::vector< std::complex< double > >::iterator pos) -> std::vector< std::complex< double > >::iterator\n"
+		"vector_complex_T_erase(vector_complex_T self, std::vector< std::complex< double > >::iterator first, std::vector< std::complex< double > >::iterator last) -> std::vector< std::complex< double > >::iterator\n"
 		""},
-	 { "new_vector_complex_t", _wrap_new_vector_complex_t, METH_VARARGS, "\n"
-		"vector_complex_t()\n"
-		"vector_complex_t(vector_complex_t other)\n"
-		"vector_complex_t(std::vector< std::complex< double > >::size_type size)\n"
-		"new_vector_complex_t(std::vector< std::complex< double > >::size_type size, std::vector< std::complex< double > >::value_type const & value) -> vector_complex_t\n"
+	 { "new_vector_complex_T", _wrap_new_vector_complex_T, METH_VARARGS, "\n"
+		"vector_complex_T()\n"
+		"vector_complex_T(vector_complex_T other)\n"
+		"vector_complex_T(std::vector< std::complex< double > >::size_type size)\n"
+		"new_vector_complex_T(std::vector< std::complex< double > >::size_type size, std::vector< std::complex< double > >::value_type const & value) -> vector_complex_T\n"
 		""},
-	 { "vector_complex_t_push_back", _wrap_vector_complex_t_push_back, METH_VARARGS, "vector_complex_t_push_back(vector_complex_t self, std::vector< std::complex< double > >::value_type const & x)"},
-	 { "vector_complex_t_front", _wrap_vector_complex_t_front, METH_O, "vector_complex_t_front(vector_complex_t self) -> std::vector< std::complex< double > >::value_type const &"},
-	 { "vector_complex_t_back", _wrap_vector_complex_t_back, METH_O, "vector_complex_t_back(vector_complex_t self) -> std::vector< std::complex< double > >::value_type const &"},
-	 { "vector_complex_t_assign", _wrap_vector_complex_t_assign, METH_VARARGS, "vector_complex_t_assign(vector_complex_t self, std::vector< std::complex< double > >::size_type n, std::vector< std::complex< double > >::value_type const & x)"},
-	 { "vector_complex_t_resize", _wrap_vector_complex_t_resize, METH_VARARGS, "\n"
-		"vector_complex_t_resize(vector_complex_t self, std::vector< std::complex< double > >::size_type new_size)\n"
-		"vector_complex_t_resize(vector_complex_t self, std::vector< std::complex< double > >::size_type new_size, std::vector< std::complex< double > >::value_type const & x)\n"
+	 { "vector_complex_T_push_back", _wrap_vector_complex_T_push_back, METH_VARARGS, "vector_complex_T_push_back(vector_complex_T self, std::vector< std::complex< double > >::value_type const & x)"},
+	 { "vector_complex_T_front", _wrap_vector_complex_T_front, METH_O, "vector_complex_T_front(vector_complex_T self) -> std::vector< std::complex< double > >::value_type const &"},
+	 { "vector_complex_T_back", _wrap_vector_complex_T_back, METH_O, "vector_complex_T_back(vector_complex_T self) -> std::vector< std::complex< double > >::value_type const &"},
+	 { "vector_complex_T_assign", _wrap_vector_complex_T_assign, METH_VARARGS, "vector_complex_T_assign(vector_complex_T self, std::vector< std::complex< double > >::size_type n, std::vector< std::complex< double > >::value_type const & x)"},
+	 { "vector_complex_T_resize", _wrap_vector_complex_T_resize, METH_VARARGS, "\n"
+		"vector_complex_T_resize(vector_complex_T self, std::vector< std::complex< double > >::size_type new_size)\n"
+		"vector_complex_T_resize(vector_complex_T self, std::vector< std::complex< double > >::size_type new_size, std::vector< std::complex< double > >::value_type const & x)\n"
 		""},
-	 { "vector_complex_t_insert", _wrap_vector_complex_t_insert, METH_VARARGS, "\n"
-		"vector_complex_t_insert(vector_complex_t self, std::vector< std::complex< double > >::iterator pos, std::vector< std::complex< double > >::value_type const & x) -> std::vector< std::complex< double > >::iterator\n"
-		"vector_complex_t_insert(vector_complex_t self, std::vector< std::complex< double > >::iterator pos, std::vector< std::complex< double > >::size_type n, std::vector< std::complex< double > >::value_type const & x)\n"
+	 { "vector_complex_T_insert", _wrap_vector_complex_T_insert, METH_VARARGS, "\n"
+		"vector_complex_T_insert(vector_complex_T self, std::vector< std::complex< double > >::iterator pos, std::vector< std::complex< double > >::value_type const & x) -> std::vector< std::complex< double > >::iterator\n"
+		"vector_complex_T_insert(vector_complex_T self, std::vector< std::complex< double > >::iterator pos, std::vector< std::complex< double > >::size_type n, std::vector< std::complex< double > >::value_type const & x)\n"
 		""},
-	 { "vector_complex_t_reserve", _wrap_vector_complex_t_reserve, METH_VARARGS, "vector_complex_t_reserve(vector_complex_t self, std::vector< std::complex< double > >::size_type n)"},
-	 { "vector_complex_t_capacity", _wrap_vector_complex_t_capacity, METH_O, "vector_complex_t_capacity(vector_complex_t self) -> std::vector< std::complex< double > >::size_type"},
-	 { "delete_vector_complex_t", _wrap_delete_vector_complex_t, METH_O, "delete_vector_complex_t(vector_complex_t self)"},
-	 { "vector_complex_t_swigregister", vector_complex_t_swigregister, METH_O, NULL},
-	 { "vector_complex_t_swiginit", vector_complex_t_swiginit, METH_VARARGS, NULL},
-	 { "vector_string_t_iterator", _wrap_vector_string_t_iterator, METH_O, "vector_string_t_iterator(vector_string_t self) -> SwigPyIterator"},
-	 { "vector_string_t___nonzero__", _wrap_vector_string_t___nonzero__, METH_O, "vector_string_t___nonzero__(vector_string_t self) -> bool"},
-	 { "vector_string_t___bool__", _wrap_vector_string_t___bool__, METH_O, "vector_string_t___bool__(vector_string_t self) -> bool"},
-	 { "vector_string_t___len__", _wrap_vector_string_t___len__, METH_O, "vector_string_t___len__(vector_string_t self) -> std::vector< std::string >::size_type"},
-	 { "vector_string_t___getslice__", _wrap_vector_string_t___getslice__, METH_VARARGS, "vector_string_t___getslice__(vector_string_t self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j) -> vector_string_t"},
-	 { "vector_string_t___setslice__", _wrap_vector_string_t___setslice__, METH_VARARGS, "\n"
-		"vector_string_t___setslice__(vector_string_t self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j)\n"
-		"vector_string_t___setslice__(vector_string_t self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j, vector_string_t v)\n"
+	 { "vector_complex_T_reserve", _wrap_vector_complex_T_reserve, METH_VARARGS, "vector_complex_T_reserve(vector_complex_T self, std::vector< std::complex< double > >::size_type n)"},
+	 { "vector_complex_T_capacity", _wrap_vector_complex_T_capacity, METH_O, "vector_complex_T_capacity(vector_complex_T self) -> std::vector< std::complex< double > >::size_type"},
+	 { "delete_vector_complex_T", _wrap_delete_vector_complex_T, METH_O, "delete_vector_complex_T(vector_complex_T self)"},
+	 { "vector_complex_T_swigregister", vector_complex_T_swigregister, METH_O, NULL},
+	 { "vector_complex_T_swiginit", vector_complex_T_swiginit, METH_VARARGS, NULL},
+	 { "vector_string_T_iterator", _wrap_vector_string_T_iterator, METH_O, "vector_string_T_iterator(vector_string_T self) -> SwigPyIterator"},
+	 { "vector_string_T___nonzero__", _wrap_vector_string_T___nonzero__, METH_O, "vector_string_T___nonzero__(vector_string_T self) -> bool"},
+	 { "vector_string_T___bool__", _wrap_vector_string_T___bool__, METH_O, "vector_string_T___bool__(vector_string_T self) -> bool"},
+	 { "vector_string_T___len__", _wrap_vector_string_T___len__, METH_O, "vector_string_T___len__(vector_string_T self) -> std::vector< std::string >::size_type"},
+	 { "vector_string_T___getslice__", _wrap_vector_string_T___getslice__, METH_VARARGS, "vector_string_T___getslice__(vector_string_T self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j) -> vector_string_T"},
+	 { "vector_string_T___setslice__", _wrap_vector_string_T___setslice__, METH_VARARGS, "\n"
+		"vector_string_T___setslice__(vector_string_T self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j)\n"
+		"vector_string_T___setslice__(vector_string_T self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j, vector_string_T v)\n"
 		""},
-	 { "vector_string_t___delslice__", _wrap_vector_string_t___delslice__, METH_VARARGS, "vector_string_t___delslice__(vector_string_t self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j)"},
-	 { "vector_string_t___delitem__", _wrap_vector_string_t___delitem__, METH_VARARGS, "\n"
-		"vector_string_t___delitem__(vector_string_t self, std::vector< std::string >::difference_type i)\n"
-		"vector_string_t___delitem__(vector_string_t self, SWIGPY_SLICEOBJECT * slice)\n"
+	 { "vector_string_T___delslice__", _wrap_vector_string_T___delslice__, METH_VARARGS, "vector_string_T___delslice__(vector_string_T self, std::vector< std::string >::difference_type i, std::vector< std::string >::difference_type j)"},
+	 { "vector_string_T___delitem__", _wrap_vector_string_T___delitem__, METH_VARARGS, "\n"
+		"vector_string_T___delitem__(vector_string_T self, std::vector< std::string >::difference_type i)\n"
+		"vector_string_T___delitem__(vector_string_T self, SWIGPY_SLICEOBJECT * slice)\n"
 		""},
-	 { "vector_string_t___getitem__", _wrap_vector_string_t___getitem__, METH_VARARGS, "\n"
-		"vector_string_t___getitem__(vector_string_t self, SWIGPY_SLICEOBJECT * slice) -> vector_string_t\n"
-		"vector_string_t___getitem__(vector_string_t self, std::vector< std::string >::difference_type i) -> std::vector< std::string >::value_type const &\n"
+	 { "vector_string_T___getitem__", _wrap_vector_string_T___getitem__, METH_VARARGS, "\n"
+		"vector_string_T___getitem__(vector_string_T self, SWIGPY_SLICEOBJECT * slice) -> vector_string_T\n"
+		"vector_string_T___getitem__(vector_string_T self, std::vector< std::string >::difference_type i) -> std::vector< std::string >::value_type const &\n"
 		""},
-	 { "vector_string_t___setitem__", _wrap_vector_string_t___setitem__, METH_VARARGS, "\n"
-		"vector_string_t___setitem__(vector_string_t self, SWIGPY_SLICEOBJECT * slice, vector_string_t v)\n"
-		"vector_string_t___setitem__(vector_string_t self, SWIGPY_SLICEOBJECT * slice)\n"
-		"vector_string_t___setitem__(vector_string_t self, std::vector< std::string >::difference_type i, std::vector< std::string >::value_type const & x)\n"
+	 { "vector_string_T___setitem__", _wrap_vector_string_T___setitem__, METH_VARARGS, "\n"
+		"vector_string_T___setitem__(vector_string_T self, SWIGPY_SLICEOBJECT * slice, vector_string_T v)\n"
+		"vector_string_T___setitem__(vector_string_T self, SWIGPY_SLICEOBJECT * slice)\n"
+		"vector_string_T___setitem__(vector_string_T self, std::vector< std::string >::difference_type i, std::vector< std::string >::value_type const & x)\n"
 		""},
-	 { "vector_string_t_pop", _wrap_vector_string_t_pop, METH_O, "vector_string_t_pop(vector_string_t self) -> std::vector< std::string >::value_type"},
-	 { "vector_string_t_append", _wrap_vector_string_t_append, METH_VARARGS, "vector_string_t_append(vector_string_t self, std::vector< std::string >::value_type const & x)"},
-	 { "vector_string_t_empty", _wrap_vector_string_t_empty, METH_O, "vector_string_t_empty(vector_string_t self) -> bool"},
-	 { "vector_string_t_size", _wrap_vector_string_t_size, METH_O, "vector_string_t_size(vector_string_t self) -> std::vector< std::string >::size_type"},
-	 { "vector_string_t_swap", _wrap_vector_string_t_swap, METH_VARARGS, "vector_string_t_swap(vector_string_t self, vector_string_t v)"},
-	 { "vector_string_t_begin", _wrap_vector_string_t_begin, METH_O, "vector_string_t_begin(vector_string_t self) -> std::vector< std::string >::iterator"},
-	 { "vector_string_t_end", _wrap_vector_string_t_end, METH_O, "vector_string_t_end(vector_string_t self) -> std::vector< std::string >::iterator"},
-	 { "vector_string_t_rbegin", _wrap_vector_string_t_rbegin, METH_O, "vector_string_t_rbegin(vector_string_t self) -> std::vector< std::string >::reverse_iterator"},
-	 { "vector_string_t_rend", _wrap_vector_string_t_rend, METH_O, "vector_string_t_rend(vector_string_t self) -> std::vector< std::string >::reverse_iterator"},
-	 { "vector_string_t_clear", _wrap_vector_string_t_clear, METH_O, "vector_string_t_clear(vector_string_t self)"},
-	 { "vector_string_t_get_allocator", _wrap_vector_string_t_get_allocator, METH_O, "vector_string_t_get_allocator(vector_string_t self) -> std::vector< std::string >::allocator_type"},
-	 { "vector_string_t_pop_back", _wrap_vector_string_t_pop_back, METH_O, "vector_string_t_pop_back(vector_string_t self)"},
-	 { "vector_string_t_erase", _wrap_vector_string_t_erase, METH_VARARGS, "\n"
-		"vector_string_t_erase(vector_string_t self, std::vector< std::string >::iterator pos) -> std::vector< std::string >::iterator\n"
-		"vector_string_t_erase(vector_string_t self, std::vector< std::string >::iterator first, std::vector< std::string >::iterator last) -> std::vector< std::string >::iterator\n"
+	 { "vector_string_T_pop", _wrap_vector_string_T_pop, METH_O, "vector_string_T_pop(vector_string_T self) -> std::vector< std::string >::value_type"},
+	 { "vector_string_T_append", _wrap_vector_string_T_append, METH_VARARGS, "vector_string_T_append(vector_string_T self, std::vector< std::string >::value_type const & x)"},
+	 { "vector_string_T_empty", _wrap_vector_string_T_empty, METH_O, "vector_string_T_empty(vector_string_T self) -> bool"},
+	 { "vector_string_T_size", _wrap_vector_string_T_size, METH_O, "vector_string_T_size(vector_string_T self) -> std::vector< std::string >::size_type"},
+	 { "vector_string_T_swap", _wrap_vector_string_T_swap, METH_VARARGS, "vector_string_T_swap(vector_string_T self, vector_string_T v)"},
+	 { "vector_string_T_begin", _wrap_vector_string_T_begin, METH_O, "vector_string_T_begin(vector_string_T self) -> std::vector< std::string >::iterator"},
+	 { "vector_string_T_end", _wrap_vector_string_T_end, METH_O, "vector_string_T_end(vector_string_T self) -> std::vector< std::string >::iterator"},
+	 { "vector_string_T_rbegin", _wrap_vector_string_T_rbegin, METH_O, "vector_string_T_rbegin(vector_string_T self) -> std::vector< std::string >::reverse_iterator"},
+	 { "vector_string_T_rend", _wrap_vector_string_T_rend, METH_O, "vector_string_T_rend(vector_string_T self) -> std::vector< std::string >::reverse_iterator"},
+	 { "vector_string_T_clear", _wrap_vector_string_T_clear, METH_O, "vector_string_T_clear(vector_string_T self)"},
+	 { "vector_string_T_get_allocator", _wrap_vector_string_T_get_allocator, METH_O, "vector_string_T_get_allocator(vector_string_T self) -> std::vector< std::string >::allocator_type"},
+	 { "vector_string_T_pop_back", _wrap_vector_string_T_pop_back, METH_O, "vector_string_T_pop_back(vector_string_T self)"},
+	 { "vector_string_T_erase", _wrap_vector_string_T_erase, METH_VARARGS, "\n"
+		"vector_string_T_erase(vector_string_T self, std::vector< std::string >::iterator pos) -> std::vector< std::string >::iterator\n"
+		"vector_string_T_erase(vector_string_T self, std::vector< std::string >::iterator first, std::vector< std::string >::iterator last) -> std::vector< std::string >::iterator\n"
 		""},
-	 { "new_vector_string_t", _wrap_new_vector_string_t, METH_VARARGS, "\n"
-		"vector_string_t()\n"
-		"vector_string_t(vector_string_t other)\n"
-		"vector_string_t(std::vector< std::string >::size_type size)\n"
-		"new_vector_string_t(std::vector< std::string >::size_type size, std::vector< std::string >::value_type const & value) -> vector_string_t\n"
+	 { "new_vector_string_T", _wrap_new_vector_string_T, METH_VARARGS, "\n"
+		"vector_string_T()\n"
+		"vector_string_T(vector_string_T other)\n"
+		"vector_string_T(std::vector< std::string >::size_type size)\n"
+		"new_vector_string_T(std::vector< std::string >::size_type size, std::vector< std::string >::value_type const & value) -> vector_string_T\n"
 		""},
-	 { "vector_string_t_push_back", _wrap_vector_string_t_push_back, METH_VARARGS, "vector_string_t_push_back(vector_string_t self, std::vector< std::string >::value_type const & x)"},
-	 { "vector_string_t_front", _wrap_vector_string_t_front, METH_O, "vector_string_t_front(vector_string_t self) -> std::vector< std::string >::value_type const &"},
-	 { "vector_string_t_back", _wrap_vector_string_t_back, METH_O, "vector_string_t_back(vector_string_t self) -> std::vector< std::string >::value_type const &"},
-	 { "vector_string_t_assign", _wrap_vector_string_t_assign, METH_VARARGS, "vector_string_t_assign(vector_string_t self, std::vector< std::string >::size_type n, std::vector< std::string >::value_type const & x)"},
-	 { "vector_string_t_resize", _wrap_vector_string_t_resize, METH_VARARGS, "\n"
-		"vector_string_t_resize(vector_string_t self, std::vector< std::string >::size_type new_size)\n"
-		"vector_string_t_resize(vector_string_t self, std::vector< std::string >::size_type new_size, std::vector< std::string >::value_type const & x)\n"
+	 { "vector_string_T_push_back", _wrap_vector_string_T_push_back, METH_VARARGS, "vector_string_T_push_back(vector_string_T self, std::vector< std::string >::value_type const & x)"},
+	 { "vector_string_T_front", _wrap_vector_string_T_front, METH_O, "vector_string_T_front(vector_string_T self) -> std::vector< std::string >::value_type const &"},
+	 { "vector_string_T_back", _wrap_vector_string_T_back, METH_O, "vector_string_T_back(vector_string_T self) -> std::vector< std::string >::value_type const &"},
+	 { "vector_string_T_assign", _wrap_vector_string_T_assign, METH_VARARGS, "vector_string_T_assign(vector_string_T self, std::vector< std::string >::size_type n, std::vector< std::string >::value_type const & x)"},
+	 { "vector_string_T_resize", _wrap_vector_string_T_resize, METH_VARARGS, "\n"
+		"vector_string_T_resize(vector_string_T self, std::vector< std::string >::size_type new_size)\n"
+		"vector_string_T_resize(vector_string_T self, std::vector< std::string >::size_type new_size, std::vector< std::string >::value_type const & x)\n"
 		""},
-	 { "vector_string_t_insert", _wrap_vector_string_t_insert, METH_VARARGS, "\n"
-		"vector_string_t_insert(vector_string_t self, std::vector< std::string >::iterator pos, std::vector< std::string >::value_type const & x) -> std::vector< std::string >::iterator\n"
-		"vector_string_t_insert(vector_string_t self, std::vector< std::string >::iterator pos, std::vector< std::string >::size_type n, std::vector< std::string >::value_type const & x)\n"
+	 { "vector_string_T_insert", _wrap_vector_string_T_insert, METH_VARARGS, "\n"
+		"vector_string_T_insert(vector_string_T self, std::vector< std::string >::iterator pos, std::vector< std::string >::value_type const & x) -> std::vector< std::string >::iterator\n"
+		"vector_string_T_insert(vector_string_T self, std::vector< std::string >::iterator pos, std::vector< std::string >::size_type n, std::vector< std::string >::value_type const & x)\n"
 		""},
-	 { "vector_string_t_reserve", _wrap_vector_string_t_reserve, METH_VARARGS, "vector_string_t_reserve(vector_string_t self, std::vector< std::string >::size_type n)"},
-	 { "vector_string_t_capacity", _wrap_vector_string_t_capacity, METH_O, "vector_string_t_capacity(vector_string_t self) -> std::vector< std::string >::size_type"},
-	 { "delete_vector_string_t", _wrap_delete_vector_string_t, METH_O, "delete_vector_string_t(vector_string_t self)"},
-	 { "vector_string_t_swigregister", vector_string_t_swigregister, METH_O, NULL},
-	 { "vector_string_t_swiginit", vector_string_t_swiginit, METH_VARARGS, NULL},
-	 { "map_string_double_t_iterator", _wrap_map_string_double_t_iterator, METH_O, "map_string_double_t_iterator(map_string_double_t self) -> SwigPyIterator"},
-	 { "map_string_double_t___nonzero__", _wrap_map_string_double_t___nonzero__, METH_O, "map_string_double_t___nonzero__(map_string_double_t self) -> bool"},
-	 { "map_string_double_t___bool__", _wrap_map_string_double_t___bool__, METH_O, "map_string_double_t___bool__(map_string_double_t self) -> bool"},
-	 { "map_string_double_t___len__", _wrap_map_string_double_t___len__, METH_O, "map_string_double_t___len__(map_string_double_t self) -> std::map< std::string,double >::size_type"},
-	 { "map_string_double_t___getitem__", _wrap_map_string_double_t___getitem__, METH_VARARGS, "map_string_double_t___getitem__(map_string_double_t self, std::map< std::string,double >::key_type const & key) -> std::map< std::string,double >::mapped_type const &"},
-	 { "map_string_double_t___delitem__", _wrap_map_string_double_t___delitem__, METH_VARARGS, "map_string_double_t___delitem__(map_string_double_t self, std::map< std::string,double >::key_type const & key)"},
-	 { "map_string_double_t_has_key", _wrap_map_string_double_t_has_key, METH_VARARGS, "map_string_double_t_has_key(map_string_double_t self, std::map< std::string,double >::key_type const & key) -> bool"},
-	 { "map_string_double_t_keys", _wrap_map_string_double_t_keys, METH_O, "map_string_double_t_keys(map_string_double_t self) -> PyObject *"},
-	 { "map_string_double_t_values", _wrap_map_string_double_t_values, METH_O, "map_string_double_t_values(map_string_double_t self) -> PyObject *"},
-	 { "map_string_double_t_items", _wrap_map_string_double_t_items, METH_O, "map_string_double_t_items(map_string_double_t self) -> PyObject *"},
-	 { "map_string_double_t___contains__", _wrap_map_string_double_t___contains__, METH_VARARGS, "map_string_double_t___contains__(map_string_double_t self, std::map< std::string,double >::key_type const & key) -> bool"},
-	 { "map_string_double_t_key_iterator", _wrap_map_string_double_t_key_iterator, METH_O, "map_string_double_t_key_iterator(map_string_double_t self) -> SwigPyIterator"},
-	 { "map_string_double_t_value_iterator", _wrap_map_string_double_t_value_iterator, METH_O, "map_string_double_t_value_iterator(map_string_double_t self) -> SwigPyIterator"},
-	 { "map_string_double_t___setitem__", _wrap_map_string_double_t___setitem__, METH_VARARGS, "\n"
-		"map_string_double_t___setitem__(map_string_double_t self, std::map< std::string,double >::key_type const & key)\n"
-		"map_string_double_t___setitem__(map_string_double_t self, std::map< std::string,double >::key_type const & key, std::map< std::string,double >::mapped_type const & x)\n"
+	 { "vector_string_T_reserve", _wrap_vector_string_T_reserve, METH_VARARGS, "vector_string_T_reserve(vector_string_T self, std::vector< std::string >::size_type n)"},
+	 { "vector_string_T_capacity", _wrap_vector_string_T_capacity, METH_O, "vector_string_T_capacity(vector_string_T self) -> std::vector< std::string >::size_type"},
+	 { "delete_vector_string_T", _wrap_delete_vector_string_T, METH_O, "delete_vector_string_T(vector_string_T self)"},
+	 { "vector_string_T_swigregister", vector_string_T_swigregister, METH_O, NULL},
+	 { "vector_string_T_swiginit", vector_string_T_swiginit, METH_VARARGS, NULL},
+	 { "map_string_double_T_iterator", _wrap_map_string_double_T_iterator, METH_O, "map_string_double_T_iterator(map_string_double_T self) -> SwigPyIterator"},
+	 { "map_string_double_T___nonzero__", _wrap_map_string_double_T___nonzero__, METH_O, "map_string_double_T___nonzero__(map_string_double_T self) -> bool"},
+	 { "map_string_double_T___bool__", _wrap_map_string_double_T___bool__, METH_O, "map_string_double_T___bool__(map_string_double_T self) -> bool"},
+	 { "map_string_double_T___len__", _wrap_map_string_double_T___len__, METH_O, "map_string_double_T___len__(map_string_double_T self) -> std::map< std::string,double >::size_type"},
+	 { "map_string_double_T___getitem__", _wrap_map_string_double_T___getitem__, METH_VARARGS, "map_string_double_T___getitem__(map_string_double_T self, std::map< std::string,double >::key_type const & key) -> std::map< std::string,double >::mapped_type const &"},
+	 { "map_string_double_T___delitem__", _wrap_map_string_double_T___delitem__, METH_VARARGS, "map_string_double_T___delitem__(map_string_double_T self, std::map< std::string,double >::key_type const & key)"},
+	 { "map_string_double_T_has_key", _wrap_map_string_double_T_has_key, METH_VARARGS, "map_string_double_T_has_key(map_string_double_T self, std::map< std::string,double >::key_type const & key) -> bool"},
+	 { "map_string_double_T_keys", _wrap_map_string_double_T_keys, METH_O, "map_string_double_T_keys(map_string_double_T self) -> PyObject *"},
+	 { "map_string_double_T_values", _wrap_map_string_double_T_values, METH_O, "map_string_double_T_values(map_string_double_T self) -> PyObject *"},
+	 { "map_string_double_T_items", _wrap_map_string_double_T_items, METH_O, "map_string_double_T_items(map_string_double_T self) -> PyObject *"},
+	 { "map_string_double_T___contains__", _wrap_map_string_double_T___contains__, METH_VARARGS, "map_string_double_T___contains__(map_string_double_T self, std::map< std::string,double >::key_type const & key) -> bool"},
+	 { "map_string_double_T_key_iterator", _wrap_map_string_double_T_key_iterator, METH_O, "map_string_double_T_key_iterator(map_string_double_T self) -> SwigPyIterator"},
+	 { "map_string_double_T_value_iterator", _wrap_map_string_double_T_value_iterator, METH_O, "map_string_double_T_value_iterator(map_string_double_T self) -> SwigPyIterator"},
+	 { "map_string_double_T___setitem__", _wrap_map_string_double_T___setitem__, METH_VARARGS, "\n"
+		"map_string_double_T___setitem__(map_string_double_T self, std::map< std::string,double >::key_type const & key)\n"
+		"map_string_double_T___setitem__(map_string_double_T self, std::map< std::string,double >::key_type const & key, std::map< std::string,double >::mapped_type const & x)\n"
 		""},
-	 { "map_string_double_t_asdict", _wrap_map_string_double_t_asdict, METH_O, "map_string_double_t_asdict(map_string_double_t self) -> PyObject *"},
-	 { "new_map_string_double_t", _wrap_new_map_string_double_t, METH_VARARGS, "\n"
-		"map_string_double_t(std::less< std::string > const & other)\n"
-		"map_string_double_t()\n"
-		"new_map_string_double_t(map_string_double_t other) -> map_string_double_t\n"
+	 { "map_string_double_T_asdict", _wrap_map_string_double_T_asdict, METH_O, "map_string_double_T_asdict(map_string_double_T self) -> PyObject *"},
+	 { "new_map_string_double_T", _wrap_new_map_string_double_T, METH_VARARGS, "\n"
+		"map_string_double_T(std::less< std::string > const & other)\n"
+		"map_string_double_T()\n"
+		"new_map_string_double_T(map_string_double_T other) -> map_string_double_T\n"
 		""},
-	 { "map_string_double_t_empty", _wrap_map_string_double_t_empty, METH_O, "map_string_double_t_empty(map_string_double_t self) -> bool"},
-	 { "map_string_double_t_size", _wrap_map_string_double_t_size, METH_O, "map_string_double_t_size(map_string_double_t self) -> std::map< std::string,double >::size_type"},
-	 { "map_string_double_t_swap", _wrap_map_string_double_t_swap, METH_VARARGS, "map_string_double_t_swap(map_string_double_t self, map_string_double_t v)"},
-	 { "map_string_double_t_begin", _wrap_map_string_double_t_begin, METH_O, "map_string_double_t_begin(map_string_double_t self) -> std::map< std::string,double >::iterator"},
-	 { "map_string_double_t_end", _wrap_map_string_double_t_end, METH_O, "map_string_double_t_end(map_string_double_t self) -> std::map< std::string,double >::iterator"},
-	 { "map_string_double_t_rbegin", _wrap_map_string_double_t_rbegin, METH_O, "map_string_double_t_rbegin(map_string_double_t self) -> std::map< std::string,double >::reverse_iterator"},
-	 { "map_string_double_t_rend", _wrap_map_string_double_t_rend, METH_O, "map_string_double_t_rend(map_string_double_t self) -> std::map< std::string,double >::reverse_iterator"},
-	 { "map_string_double_t_clear", _wrap_map_string_double_t_clear, METH_O, "map_string_double_t_clear(map_string_double_t self)"},
-	 { "map_string_double_t_get_allocator", _wrap_map_string_double_t_get_allocator, METH_O, "map_string_double_t_get_allocator(map_string_double_t self) -> std::map< std::string,double >::allocator_type"},
-	 { "map_string_double_t_count", _wrap_map_string_double_t_count, METH_VARARGS, "map_string_double_t_count(map_string_double_t self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::size_type"},
-	 { "map_string_double_t_erase", _wrap_map_string_double_t_erase, METH_VARARGS, "\n"
-		"map_string_double_t_erase(map_string_double_t self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::size_type\n"
-		"map_string_double_t_erase(map_string_double_t self, std::map< std::string,double >::iterator position)\n"
-		"map_string_double_t_erase(map_string_double_t self, std::map< std::string,double >::iterator first, std::map< std::string,double >::iterator last)\n"
+	 { "map_string_double_T_empty", _wrap_map_string_double_T_empty, METH_O, "map_string_double_T_empty(map_string_double_T self) -> bool"},
+	 { "map_string_double_T_size", _wrap_map_string_double_T_size, METH_O, "map_string_double_T_size(map_string_double_T self) -> std::map< std::string,double >::size_type"},
+	 { "map_string_double_T_swap", _wrap_map_string_double_T_swap, METH_VARARGS, "map_string_double_T_swap(map_string_double_T self, map_string_double_T v)"},
+	 { "map_string_double_T_begin", _wrap_map_string_double_T_begin, METH_O, "map_string_double_T_begin(map_string_double_T self) -> std::map< std::string,double >::iterator"},
+	 { "map_string_double_T_end", _wrap_map_string_double_T_end, METH_O, "map_string_double_T_end(map_string_double_T self) -> std::map< std::string,double >::iterator"},
+	 { "map_string_double_T_rbegin", _wrap_map_string_double_T_rbegin, METH_O, "map_string_double_T_rbegin(map_string_double_T self) -> std::map< std::string,double >::reverse_iterator"},
+	 { "map_string_double_T_rend", _wrap_map_string_double_T_rend, METH_O, "map_string_double_T_rend(map_string_double_T self) -> std::map< std::string,double >::reverse_iterator"},
+	 { "map_string_double_T_clear", _wrap_map_string_double_T_clear, METH_O, "map_string_double_T_clear(map_string_double_T self)"},
+	 { "map_string_double_T_get_allocator", _wrap_map_string_double_T_get_allocator, METH_O, "map_string_double_T_get_allocator(map_string_double_T self) -> std::map< std::string,double >::allocator_type"},
+	 { "map_string_double_T_count", _wrap_map_string_double_T_count, METH_VARARGS, "map_string_double_T_count(map_string_double_T self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::size_type"},
+	 { "map_string_double_T_erase", _wrap_map_string_double_T_erase, METH_VARARGS, "\n"
+		"map_string_double_T_erase(map_string_double_T self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::size_type\n"
+		"map_string_double_T_erase(map_string_double_T self, std::map< std::string,double >::iterator position)\n"
+		"map_string_double_T_erase(map_string_double_T self, std::map< std::string,double >::iterator first, std::map< std::string,double >::iterator last)\n"
 		""},
-	 { "map_string_double_t_find", _wrap_map_string_double_t_find, METH_VARARGS, "map_string_double_t_find(map_string_double_t self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"},
-	 { "map_string_double_t_lower_bound", _wrap_map_string_double_t_lower_bound, METH_VARARGS, "map_string_double_t_lower_bound(map_string_double_t self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"},
-	 { "map_string_double_t_upper_bound", _wrap_map_string_double_t_upper_bound, METH_VARARGS, "map_string_double_t_upper_bound(map_string_double_t self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"},
-	 { "delete_map_string_double_t", _wrap_delete_map_string_double_t, METH_O, "delete_map_string_double_t(map_string_double_t self)"},
-	 { "map_string_double_t_swigregister", map_string_double_t_swigregister, METH_O, NULL},
-	 { "map_string_double_t_swiginit", map_string_double_t_swiginit, METH_VARARGS, NULL},
-	 { "new_pvacuum_double_t", _wrap_new_pvacuum_double_t, METH_VARARGS, "\n"
-		"pvacuum_double_t()\n"
-		"pvacuum_double_t(double first, double second)\n"
-		"new_pvacuum_double_t(pvacuum_double_t other) -> pvacuum_double_t\n"
+	 { "map_string_double_T_find", _wrap_map_string_double_T_find, METH_VARARGS, "map_string_double_T_find(map_string_double_T self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"},
+	 { "map_string_double_T_lower_bound", _wrap_map_string_double_T_lower_bound, METH_VARARGS, "map_string_double_T_lower_bound(map_string_double_T self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"},
+	 { "map_string_double_T_upper_bound", _wrap_map_string_double_T_upper_bound, METH_VARARGS, "map_string_double_T_upper_bound(map_string_double_T self, std::map< std::string,double >::key_type const & x) -> std::map< std::string,double >::iterator"},
+	 { "delete_map_string_double_T", _wrap_delete_map_string_double_T, METH_O, "delete_map_string_double_T(map_string_double_T self)"},
+	 { "map_string_double_T_swigregister", map_string_double_T_swigregister, METH_O, NULL},
+	 { "map_string_double_T_swiginit", map_string_double_T_swiginit, METH_VARARGS, NULL},
+	 { "new_pvacuum_double_T", _wrap_new_pvacuum_double_T, METH_VARARGS, "\n"
+		"pvacuum_double_T()\n"
+		"pvacuum_double_T(double first, double second)\n"
+		"new_pvacuum_double_T(pvacuum_double_T other) -> pvacuum_double_T\n"
 		""},
-	 { "pvacuum_double_t_first_set", _wrap_pvacuum_double_t_first_set, METH_VARARGS, "pvacuum_double_t_first_set(pvacuum_double_t self, double first)"},
-	 { "pvacuum_double_t_first_get", _wrap_pvacuum_double_t_first_get, METH_O, "pvacuum_double_t_first_get(pvacuum_double_t self) -> double"},
-	 { "pvacuum_double_t_second_set", _wrap_pvacuum_double_t_second_set, METH_VARARGS, "pvacuum_double_t_second_set(pvacuum_double_t self, double second)"},
-	 { "pvacuum_double_t_second_get", _wrap_pvacuum_double_t_second_get, METH_O, "pvacuum_double_t_second_get(pvacuum_double_t self) -> double"},
-	 { "delete_pvacuum_double_t", _wrap_delete_pvacuum_double_t, METH_O, "delete_pvacuum_double_t(pvacuum_double_t self)"},
-	 { "pvacuum_double_t_swigregister", pvacuum_double_t_swigregister, METH_O, NULL},
-	 { "pvacuum_double_t_swiginit", pvacuum_double_t_swiginit, METH_VARARGS, NULL},
-	 { "vector_pvacuum_double_t_iterator", _wrap_vector_pvacuum_double_t_iterator, METH_O, "vector_pvacuum_double_t_iterator(vector_pvacuum_double_t self) -> SwigPyIterator"},
-	 { "vector_pvacuum_double_t___nonzero__", _wrap_vector_pvacuum_double_t___nonzero__, METH_O, "vector_pvacuum_double_t___nonzero__(vector_pvacuum_double_t self) -> bool"},
-	 { "vector_pvacuum_double_t___bool__", _wrap_vector_pvacuum_double_t___bool__, METH_O, "vector_pvacuum_double_t___bool__(vector_pvacuum_double_t self) -> bool"},
-	 { "vector_pvacuum_double_t___len__", _wrap_vector_pvacuum_double_t___len__, METH_O, "vector_pvacuum_double_t___len__(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::size_type"},
-	 { "vector_pvacuum_double_t___getslice__", _wrap_vector_pvacuum_double_t___getslice__, METH_VARARGS, "vector_pvacuum_double_t___getslice__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j) -> vector_pvacuum_double_t"},
-	 { "vector_pvacuum_double_t___setslice__", _wrap_vector_pvacuum_double_t___setslice__, METH_VARARGS, "\n"
-		"vector_pvacuum_double_t___setslice__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j)\n"
-		"vector_pvacuum_double_t___setslice__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j, vector_pvacuum_double_t v)\n"
+	 { "pvacuum_double_T_first_set", _wrap_pvacuum_double_T_first_set, METH_VARARGS, "pvacuum_double_T_first_set(pvacuum_double_T self, double first)"},
+	 { "pvacuum_double_T_first_get", _wrap_pvacuum_double_T_first_get, METH_O, "pvacuum_double_T_first_get(pvacuum_double_T self) -> double"},
+	 { "pvacuum_double_T_second_set", _wrap_pvacuum_double_T_second_set, METH_VARARGS, "pvacuum_double_T_second_set(pvacuum_double_T self, double second)"},
+	 { "pvacuum_double_T_second_get", _wrap_pvacuum_double_T_second_get, METH_O, "pvacuum_double_T_second_get(pvacuum_double_T self) -> double"},
+	 { "delete_pvacuum_double_T", _wrap_delete_pvacuum_double_T, METH_O, "delete_pvacuum_double_T(pvacuum_double_T self)"},
+	 { "pvacuum_double_T_swigregister", pvacuum_double_T_swigregister, METH_O, NULL},
+	 { "pvacuum_double_T_swiginit", pvacuum_double_T_swiginit, METH_VARARGS, NULL},
+	 { "vector_pvacuum_double_T_iterator", _wrap_vector_pvacuum_double_T_iterator, METH_O, "vector_pvacuum_double_T_iterator(vector_pvacuum_double_T self) -> SwigPyIterator"},
+	 { "vector_pvacuum_double_T___nonzero__", _wrap_vector_pvacuum_double_T___nonzero__, METH_O, "vector_pvacuum_double_T___nonzero__(vector_pvacuum_double_T self) -> bool"},
+	 { "vector_pvacuum_double_T___bool__", _wrap_vector_pvacuum_double_T___bool__, METH_O, "vector_pvacuum_double_T___bool__(vector_pvacuum_double_T self) -> bool"},
+	 { "vector_pvacuum_double_T___len__", _wrap_vector_pvacuum_double_T___len__, METH_O, "vector_pvacuum_double_T___len__(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::size_type"},
+	 { "vector_pvacuum_double_T___getslice__", _wrap_vector_pvacuum_double_T___getslice__, METH_VARARGS, "vector_pvacuum_double_T___getslice__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j) -> vector_pvacuum_double_T"},
+	 { "vector_pvacuum_double_T___setslice__", _wrap_vector_pvacuum_double_T___setslice__, METH_VARARGS, "\n"
+		"vector_pvacuum_double_T___setslice__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j)\n"
+		"vector_pvacuum_double_T___setslice__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j, vector_pvacuum_double_T v)\n"
 		""},
-	 { "vector_pvacuum_double_t___delslice__", _wrap_vector_pvacuum_double_t___delslice__, METH_VARARGS, "vector_pvacuum_double_t___delslice__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j)"},
-	 { "vector_pvacuum_double_t___delitem__", _wrap_vector_pvacuum_double_t___delitem__, METH_VARARGS, "\n"
-		"vector_pvacuum_double_t___delitem__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i)\n"
-		"vector_pvacuum_double_t___delitem__(vector_pvacuum_double_t self, SWIGPY_SLICEOBJECT * slice)\n"
+	 { "vector_pvacuum_double_T___delslice__", _wrap_vector_pvacuum_double_T___delslice__, METH_VARARGS, "vector_pvacuum_double_T___delslice__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i, std::vector< std::pair< double,double > >::difference_type j)"},
+	 { "vector_pvacuum_double_T___delitem__", _wrap_vector_pvacuum_double_T___delitem__, METH_VARARGS, "\n"
+		"vector_pvacuum_double_T___delitem__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i)\n"
+		"vector_pvacuum_double_T___delitem__(vector_pvacuum_double_T self, SWIGPY_SLICEOBJECT * slice)\n"
 		""},
-	 { "vector_pvacuum_double_t___getitem__", _wrap_vector_pvacuum_double_t___getitem__, METH_VARARGS, "\n"
-		"vector_pvacuum_double_t___getitem__(vector_pvacuum_double_t self, SWIGPY_SLICEOBJECT * slice) -> vector_pvacuum_double_t\n"
-		"vector_pvacuum_double_t___getitem__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i) -> pvacuum_double_t\n"
+	 { "vector_pvacuum_double_T___getitem__", _wrap_vector_pvacuum_double_T___getitem__, METH_VARARGS, "\n"
+		"vector_pvacuum_double_T___getitem__(vector_pvacuum_double_T self, SWIGPY_SLICEOBJECT * slice) -> vector_pvacuum_double_T\n"
+		"vector_pvacuum_double_T___getitem__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i) -> pvacuum_double_T\n"
 		""},
-	 { "vector_pvacuum_double_t___setitem__", _wrap_vector_pvacuum_double_t___setitem__, METH_VARARGS, "\n"
-		"vector_pvacuum_double_t___setitem__(vector_pvacuum_double_t self, SWIGPY_SLICEOBJECT * slice, vector_pvacuum_double_t v)\n"
-		"vector_pvacuum_double_t___setitem__(vector_pvacuum_double_t self, SWIGPY_SLICEOBJECT * slice)\n"
-		"vector_pvacuum_double_t___setitem__(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::difference_type i, pvacuum_double_t x)\n"
+	 { "vector_pvacuum_double_T___setitem__", _wrap_vector_pvacuum_double_T___setitem__, METH_VARARGS, "\n"
+		"vector_pvacuum_double_T___setitem__(vector_pvacuum_double_T self, SWIGPY_SLICEOBJECT * slice, vector_pvacuum_double_T v)\n"
+		"vector_pvacuum_double_T___setitem__(vector_pvacuum_double_T self, SWIGPY_SLICEOBJECT * slice)\n"
+		"vector_pvacuum_double_T___setitem__(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::difference_type i, pvacuum_double_T x)\n"
 		""},
-	 { "vector_pvacuum_double_t_pop", _wrap_vector_pvacuum_double_t_pop, METH_O, "vector_pvacuum_double_t_pop(vector_pvacuum_double_t self) -> pvacuum_double_t"},
-	 { "vector_pvacuum_double_t_append", _wrap_vector_pvacuum_double_t_append, METH_VARARGS, "vector_pvacuum_double_t_append(vector_pvacuum_double_t self, pvacuum_double_t x)"},
-	 { "vector_pvacuum_double_t_empty", _wrap_vector_pvacuum_double_t_empty, METH_O, "vector_pvacuum_double_t_empty(vector_pvacuum_double_t self) -> bool"},
-	 { "vector_pvacuum_double_t_size", _wrap_vector_pvacuum_double_t_size, METH_O, "vector_pvacuum_double_t_size(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::size_type"},
-	 { "vector_pvacuum_double_t_swap", _wrap_vector_pvacuum_double_t_swap, METH_VARARGS, "vector_pvacuum_double_t_swap(vector_pvacuum_double_t self, vector_pvacuum_double_t v)"},
-	 { "vector_pvacuum_double_t_begin", _wrap_vector_pvacuum_double_t_begin, METH_O, "vector_pvacuum_double_t_begin(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::iterator"},
-	 { "vector_pvacuum_double_t_end", _wrap_vector_pvacuum_double_t_end, METH_O, "vector_pvacuum_double_t_end(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::iterator"},
-	 { "vector_pvacuum_double_t_rbegin", _wrap_vector_pvacuum_double_t_rbegin, METH_O, "vector_pvacuum_double_t_rbegin(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::reverse_iterator"},
-	 { "vector_pvacuum_double_t_rend", _wrap_vector_pvacuum_double_t_rend, METH_O, "vector_pvacuum_double_t_rend(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::reverse_iterator"},
-	 { "vector_pvacuum_double_t_clear", _wrap_vector_pvacuum_double_t_clear, METH_O, "vector_pvacuum_double_t_clear(vector_pvacuum_double_t self)"},
-	 { "vector_pvacuum_double_t_get_allocator", _wrap_vector_pvacuum_double_t_get_allocator, METH_O, "vector_pvacuum_double_t_get_allocator(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::allocator_type"},
-	 { "vector_pvacuum_double_t_pop_back", _wrap_vector_pvacuum_double_t_pop_back, METH_O, "vector_pvacuum_double_t_pop_back(vector_pvacuum_double_t self)"},
-	 { "vector_pvacuum_double_t_erase", _wrap_vector_pvacuum_double_t_erase, METH_VARARGS, "\n"
-		"vector_pvacuum_double_t_erase(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::iterator pos) -> std::vector< std::pair< double,double > >::iterator\n"
-		"vector_pvacuum_double_t_erase(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::iterator first, std::vector< std::pair< double,double > >::iterator last) -> std::vector< std::pair< double,double > >::iterator\n"
+	 { "vector_pvacuum_double_T_pop", _wrap_vector_pvacuum_double_T_pop, METH_O, "vector_pvacuum_double_T_pop(vector_pvacuum_double_T self) -> pvacuum_double_T"},
+	 { "vector_pvacuum_double_T_append", _wrap_vector_pvacuum_double_T_append, METH_VARARGS, "vector_pvacuum_double_T_append(vector_pvacuum_double_T self, pvacuum_double_T x)"},
+	 { "vector_pvacuum_double_T_empty", _wrap_vector_pvacuum_double_T_empty, METH_O, "vector_pvacuum_double_T_empty(vector_pvacuum_double_T self) -> bool"},
+	 { "vector_pvacuum_double_T_size", _wrap_vector_pvacuum_double_T_size, METH_O, "vector_pvacuum_double_T_size(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::size_type"},
+	 { "vector_pvacuum_double_T_swap", _wrap_vector_pvacuum_double_T_swap, METH_VARARGS, "vector_pvacuum_double_T_swap(vector_pvacuum_double_T self, vector_pvacuum_double_T v)"},
+	 { "vector_pvacuum_double_T_begin", _wrap_vector_pvacuum_double_T_begin, METH_O, "vector_pvacuum_double_T_begin(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::iterator"},
+	 { "vector_pvacuum_double_T_end", _wrap_vector_pvacuum_double_T_end, METH_O, "vector_pvacuum_double_T_end(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::iterator"},
+	 { "vector_pvacuum_double_T_rbegin", _wrap_vector_pvacuum_double_T_rbegin, METH_O, "vector_pvacuum_double_T_rbegin(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::reverse_iterator"},
+	 { "vector_pvacuum_double_T_rend", _wrap_vector_pvacuum_double_T_rend, METH_O, "vector_pvacuum_double_T_rend(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::reverse_iterator"},
+	 { "vector_pvacuum_double_T_clear", _wrap_vector_pvacuum_double_T_clear, METH_O, "vector_pvacuum_double_T_clear(vector_pvacuum_double_T self)"},
+	 { "vector_pvacuum_double_T_get_allocator", _wrap_vector_pvacuum_double_T_get_allocator, METH_O, "vector_pvacuum_double_T_get_allocator(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::allocator_type"},
+	 { "vector_pvacuum_double_T_pop_back", _wrap_vector_pvacuum_double_T_pop_back, METH_O, "vector_pvacuum_double_T_pop_back(vector_pvacuum_double_T self)"},
+	 { "vector_pvacuum_double_T_erase", _wrap_vector_pvacuum_double_T_erase, METH_VARARGS, "\n"
+		"vector_pvacuum_double_T_erase(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::iterator pos) -> std::vector< std::pair< double,double > >::iterator\n"
+		"vector_pvacuum_double_T_erase(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::iterator first, std::vector< std::pair< double,double > >::iterator last) -> std::vector< std::pair< double,double > >::iterator\n"
 		""},
-	 { "new_vector_pvacuum_double_t", _wrap_new_vector_pvacuum_double_t, METH_VARARGS, "\n"
-		"vector_pvacuum_double_t()\n"
-		"vector_pvacuum_double_t(vector_pvacuum_double_t other)\n"
-		"vector_pvacuum_double_t(std::vector< std::pair< double,double > >::size_type size)\n"
-		"new_vector_pvacuum_double_t(std::vector< std::pair< double,double > >::size_type size, pvacuum_double_t value) -> vector_pvacuum_double_t\n"
+	 { "new_vector_pvacuum_double_T", _wrap_new_vector_pvacuum_double_T, METH_VARARGS, "\n"
+		"vector_pvacuum_double_T()\n"
+		"vector_pvacuum_double_T(vector_pvacuum_double_T other)\n"
+		"vector_pvacuum_double_T(std::vector< std::pair< double,double > >::size_type size)\n"
+		"new_vector_pvacuum_double_T(std::vector< std::pair< double,double > >::size_type size, pvacuum_double_T value) -> vector_pvacuum_double_T\n"
 		""},
-	 { "vector_pvacuum_double_t_push_back", _wrap_vector_pvacuum_double_t_push_back, METH_VARARGS, "vector_pvacuum_double_t_push_back(vector_pvacuum_double_t self, pvacuum_double_t x)"},
-	 { "vector_pvacuum_double_t_front", _wrap_vector_pvacuum_double_t_front, METH_O, "vector_pvacuum_double_t_front(vector_pvacuum_double_t self) -> pvacuum_double_t"},
-	 { "vector_pvacuum_double_t_back", _wrap_vector_pvacuum_double_t_back, METH_O, "vector_pvacuum_double_t_back(vector_pvacuum_double_t self) -> pvacuum_double_t"},
-	 { "vector_pvacuum_double_t_assign", _wrap_vector_pvacuum_double_t_assign, METH_VARARGS, "vector_pvacuum_double_t_assign(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::size_type n, pvacuum_double_t x)"},
-	 { "vector_pvacuum_double_t_resize", _wrap_vector_pvacuum_double_t_resize, METH_VARARGS, "\n"
-		"vector_pvacuum_double_t_resize(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::size_type new_size)\n"
-		"vector_pvacuum_double_t_resize(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::size_type new_size, pvacuum_double_t x)\n"
+	 { "vector_pvacuum_double_T_push_back", _wrap_vector_pvacuum_double_T_push_back, METH_VARARGS, "vector_pvacuum_double_T_push_back(vector_pvacuum_double_T self, pvacuum_double_T x)"},
+	 { "vector_pvacuum_double_T_front", _wrap_vector_pvacuum_double_T_front, METH_O, "vector_pvacuum_double_T_front(vector_pvacuum_double_T self) -> pvacuum_double_T"},
+	 { "vector_pvacuum_double_T_back", _wrap_vector_pvacuum_double_T_back, METH_O, "vector_pvacuum_double_T_back(vector_pvacuum_double_T self) -> pvacuum_double_T"},
+	 { "vector_pvacuum_double_T_assign", _wrap_vector_pvacuum_double_T_assign, METH_VARARGS, "vector_pvacuum_double_T_assign(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::size_type n, pvacuum_double_T x)"},
+	 { "vector_pvacuum_double_T_resize", _wrap_vector_pvacuum_double_T_resize, METH_VARARGS, "\n"
+		"vector_pvacuum_double_T_resize(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::size_type new_size)\n"
+		"vector_pvacuum_double_T_resize(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::size_type new_size, pvacuum_double_T x)\n"
 		""},
-	 { "vector_pvacuum_double_t_insert", _wrap_vector_pvacuum_double_t_insert, METH_VARARGS, "\n"
-		"vector_pvacuum_double_t_insert(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::iterator pos, pvacuum_double_t x) -> std::vector< std::pair< double,double > >::iterator\n"
-		"vector_pvacuum_double_t_insert(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::iterator pos, std::vector< std::pair< double,double > >::size_type n, pvacuum_double_t x)\n"
+	 { "vector_pvacuum_double_T_insert", _wrap_vector_pvacuum_double_T_insert, METH_VARARGS, "\n"
+		"vector_pvacuum_double_T_insert(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::iterator pos, pvacuum_double_T x) -> std::vector< std::pair< double,double > >::iterator\n"
+		"vector_pvacuum_double_T_insert(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::iterator pos, std::vector< std::pair< double,double > >::size_type n, pvacuum_double_T x)\n"
 		""},
-	 { "vector_pvacuum_double_t_reserve", _wrap_vector_pvacuum_double_t_reserve, METH_VARARGS, "vector_pvacuum_double_t_reserve(vector_pvacuum_double_t self, std::vector< std::pair< double,double > >::size_type n)"},
-	 { "vector_pvacuum_double_t_capacity", _wrap_vector_pvacuum_double_t_capacity, METH_O, "vector_pvacuum_double_t_capacity(vector_pvacuum_double_t self) -> std::vector< std::pair< double,double > >::size_type"},
-	 { "delete_vector_pvacuum_double_t", _wrap_delete_vector_pvacuum_double_t, METH_O, "delete_vector_pvacuum_double_t(vector_pvacuum_double_t self)"},
-	 { "vector_pvacuum_double_t_swigregister", vector_pvacuum_double_t_swigregister, METH_O, NULL},
-	 { "vector_pvacuum_double_t_swiginit", vector_pvacuum_double_t_swiginit, METH_VARARGS, NULL},
+	 { "vector_pvacuum_double_T_reserve", _wrap_vector_pvacuum_double_T_reserve, METH_VARARGS, "vector_pvacuum_double_T_reserve(vector_pvacuum_double_T self, std::vector< std::pair< double,double > >::size_type n)"},
+	 { "vector_pvacuum_double_T_capacity", _wrap_vector_pvacuum_double_T_capacity, METH_O, "vector_pvacuum_double_T_capacity(vector_pvacuum_double_T self) -> std::vector< std::pair< double,double > >::size_type"},
+	 { "delete_vector_pvacuum_double_T", _wrap_delete_vector_pvacuum_double_T, METH_O, "delete_vector_pvacuum_double_T(vector_pvacuum_double_T self)"},
+	 { "vector_pvacuum_double_T_swigregister", vector_pvacuum_double_T_swigregister, METH_O, NULL},
+	 { "vector_pvacuum_double_T_swiginit", vector_pvacuum_double_T_swiginit, METH_VARARGS, NULL},
 	 { "new_R3", _wrap_new_R3, METH_VARARGS, "\n"
 		"R3(double const x_, double const y_, double const z_)\n"
 		"new_R3() -> R3\n"
@@ -39684,7 +39684,7 @@ static PyMethodDef SwigMethods[] = {
 	 { "IterationInfo_iterationCount", _wrap_IterationInfo_iterationCount, METH_O, "IterationInfo_iterationCount(IterationInfo self) -> unsigned int"},
 	 { "IterationInfo_chi2", _wrap_IterationInfo_chi2, METH_O, "IterationInfo_chi2(IterationInfo self) -> double"},
 	 { "IterationInfo_parameters", _wrap_IterationInfo_parameters, METH_O, "IterationInfo_parameters(IterationInfo self) -> mumufit::Parameters"},
-	 { "IterationInfo_parameterMap", _wrap_IterationInfo_parameterMap, METH_O, "IterationInfo_parameterMap(IterationInfo self) -> map_string_double_t"},
+	 { "IterationInfo_parameterMap", _wrap_IterationInfo_parameterMap, METH_O, "IterationInfo_parameterMap(IterationInfo self) -> map_string_double_T"},
 	 { "delete_IterationInfo", _wrap_delete_IterationInfo, METH_O, "delete_IterationInfo(IterationInfo self)"},
 	 { "IterationInfo_swigregister", IterationInfo_swigregister, METH_O, NULL},
 	 { "IterationInfo_swiginit", IterationInfo_swiginit, METH_VARARGS, NULL},
@@ -39704,13 +39704,13 @@ static PyMethodDef SwigMethods[] = {
 	 { "delete_FitObjective", _wrap_delete_FitObjective, METH_O, "delete_FitObjective(FitObjective self)"},
 	 { "FitObjective_addFitPair_cpp", _wrap_FitObjective_addFitPair_cpp, METH_VARARGS, "FitObjective_addFitPair_cpp(FitObjective self, PyBuilderCallback callback, Datafield expData, double weight=1.0)"},
 	 { "FitObjective_evaluate_cpp", _wrap_FitObjective_evaluate_cpp, METH_VARARGS, "FitObjective_evaluate_cpp(FitObjective self, mumufit::Parameters const & params) -> double"},
-	 { "FitObjective_evaluate_residuals_cpp", _wrap_FitObjective_evaluate_residuals_cpp, METH_VARARGS, "FitObjective_evaluate_residuals_cpp(FitObjective self, mumufit::Parameters const & params) -> vdouble1d_t"},
+	 { "FitObjective_evaluate_residuals_cpp", _wrap_FitObjective_evaluate_residuals_cpp, METH_VARARGS, "FitObjective_evaluate_residuals_cpp(FitObjective self, mumufit::Parameters const & params) -> vdouble1d_T"},
 	 { "FitObjective_simulationResult", _wrap_FitObjective_simulationResult, METH_VARARGS, "FitObjective_simulationResult(FitObjective self, size_t i_item=0) -> Datafield"},
 	 { "FitObjective_experimentalData", _wrap_FitObjective_experimentalData, METH_VARARGS, "FitObjective_experimentalData(FitObjective self, size_t i_item=0) -> Datafield"},
 	 { "FitObjective_relativeDifference", _wrap_FitObjective_relativeDifference, METH_VARARGS, "FitObjective_relativeDifference(FitObjective self, size_t i_item=0) -> Datafield"},
 	 { "FitObjective_absoluteDifference", _wrap_FitObjective_absoluteDifference, METH_VARARGS, "FitObjective_absoluteDifference(FitObjective self, size_t i_item=0) -> Datafield"},
-	 { "FitObjective_flatExpData", _wrap_FitObjective_flatExpData, METH_O, "FitObjective_flatExpData(FitObjective self) -> vdouble1d_t"},
-	 { "FitObjective_flatSimData", _wrap_FitObjective_flatSimData, METH_O, "FitObjective_flatSimData(FitObjective self) -> vdouble1d_t"},
+	 { "FitObjective_flatExpData", _wrap_FitObjective_flatExpData, METH_O, "FitObjective_flatExpData(FitObjective self) -> vdouble1d_T"},
+	 { "FitObjective_flatSimData", _wrap_FitObjective_flatSimData, METH_O, "FitObjective_flatSimData(FitObjective self) -> vdouble1d_T"},
 	 { "FitObjective_initPrint", _wrap_FitObjective_initPrint, METH_VARARGS, "FitObjective_initPrint(FitObjective self, int every_nth)"},
 	 { "FitObjective_initPlot_cpp", _wrap_FitObjective_initPlot_cpp, METH_VARARGS, "FitObjective_initPlot_cpp(FitObjective self, int every_nth, PyObserverCallback callback)"},
 	 { "FitObjective_iterationInfo", _wrap_FitObjective_iterationInfo, METH_O, "FitObjective_iterationInfo(FitObjective self) -> IterationInfo"},
@@ -39746,7 +39746,7 @@ static PyMethodDef SwigMethods[] = {
 	 { "PhysicalScan_swigregister", PhysicalScan_swigregister, METH_O, NULL},
 	 { "new_AlphaScan", _wrap_new_AlphaScan, METH_VARARGS, "\n"
 		"AlphaScan(Scale alpha_axis)\n"
-		"AlphaScan(vdouble1d_t points)\n"
+		"AlphaScan(vdouble1d_T points)\n"
 		"new_AlphaScan(int nbins, double alpha_i_min, double alpha_i_max) -> AlphaScan\n"
 		""},
 	 { "delete_AlphaScan", _wrap_delete_AlphaScan, METH_O, "delete_AlphaScan(AlphaScan self)"},
@@ -39757,7 +39757,7 @@ static PyMethodDef SwigMethods[] = {
 	 { "AlphaScan_swiginit", AlphaScan_swiginit, METH_VARARGS, NULL},
 	 { "new_LambdaScan", _wrap_new_LambdaScan, METH_VARARGS, "\n"
 		"LambdaScan(Scale lambdaScale)\n"
-		"LambdaScan(vdouble1d_t points)\n"
+		"LambdaScan(vdouble1d_T points)\n"
 		"new_LambdaScan(int nbins, double lambda_min, double lambda_max) -> LambdaScan\n"
 		""},
 	 { "delete_LambdaScan", _wrap_delete_LambdaScan, METH_O, "delete_LambdaScan(LambdaScan self)"},
@@ -39766,7 +39766,7 @@ static PyMethodDef SwigMethods[] = {
 	 { "LambdaScan_swigregister", LambdaScan_swigregister, METH_O, NULL},
 	 { "LambdaScan_swiginit", LambdaScan_swiginit, METH_VARARGS, NULL},
 	 { "new_QzScan", _wrap_new_QzScan, METH_VARARGS, "\n"
-		"QzScan(vdouble1d_t qs_nm)\n"
+		"QzScan(vdouble1d_T qs_nm)\n"
 		"QzScan(Scale qs_nm)\n"
 		"new_QzScan(int nbins, double qz_min, double qz_max) -> QzScan\n"
 		""},
@@ -39776,7 +39776,7 @@ static PyMethodDef SwigMethods[] = {
 	 { "QzScan_nodeChildren", _wrap_QzScan_nodeChildren, METH_O, "QzScan_nodeChildren(QzScan self) -> swig_dummy_type_const_inode_vector"},
 	 { "QzScan_setRelativeQResolution", _wrap_QzScan_setRelativeQResolution, METH_VARARGS, "QzScan_setRelativeQResolution(QzScan self, IDistribution1D const & distr, double rel_dev)"},
 	 { "QzScan_setAbsoluteQResolution", _wrap_QzScan_setAbsoluteQResolution, METH_VARARGS, "QzScan_setAbsoluteQResolution(QzScan self, IDistribution1D const & distr, double std_dev)"},
-	 { "QzScan_setVectorResolution", _wrap_QzScan_setVectorResolution, METH_VARARGS, "QzScan_setVectorResolution(QzScan self, IDistribution1D const & distr, vdouble1d_t std_devs)"},
+	 { "QzScan_setVectorResolution", _wrap_QzScan_setVectorResolution, METH_VARARGS, "QzScan_setVectorResolution(QzScan self, IDistribution1D const & distr, vdouble1d_T std_devs)"},
 	 { "QzScan_setOffset", _wrap_QzScan_setOffset, METH_VARARGS, "QzScan_setOffset(QzScan self, double offset)"},
 	 { "QzScan_swigregister", QzScan_swigregister, METH_O, NULL},
 	 { "QzScan_swiginit", QzScan_swiginit, METH_VARARGS, NULL},
@@ -39814,7 +39814,7 @@ static PyMethodDef SwigMethods[] = {
 	 { "IBackground_addBackground", _wrap_IBackground_addBackground, METH_VARARGS, "IBackground_addBackground(IBackground self, double element) -> double"},
 	 { "IBackground_swigregister", IBackground_swigregister, METH_O, NULL},
 	 { "new_ConstantBackground", _wrap_new_ConstantBackground, METH_VARARGS, "\n"
-		"ConstantBackground(vdouble1d_t P)\n"
+		"ConstantBackground(vdouble1d_T P)\n"
 		"new_ConstantBackground(double background_value) -> ConstantBackground\n"
 		""},
 	 { "ConstantBackground_clone", _wrap_ConstantBackground_clone, METH_O, "ConstantBackground_clone(ConstantBackground self) -> ConstantBackground"},